# HG changeset patch # User ecology # Date 1673271425 0 # Node ID 33a1e15f725297a033bddb3fa18324439a93bc18 planemo upload for repository https://github.com/Marie59/Sentinel_2A/srs_tools commit b32737c1642aa02cc672534e42c5cb4abe0cd3e7 diff -r 000000000000 -r 33a1e15f7252 Lib_preprocess_S2.r --- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/Lib_preprocess_S2.r Mon Jan 09 13:37:05 2023 +0000 @@ -0,0 +1,1335 @@ +# == == == == == == == == == == == == == == == == == == == == == == == == == == == +# preprocS2 +# Lib_preprocess_S2.R +# == == == == == == == == == == == == == == == == == == == == == == == == == == == +# PROGRAMMERS: +# Jean-Baptiste FERET +# Copyright 2021/08 Jean-Baptiste FERET +# == == == == == == == == == == == == == == == == == == == == == == == == == == == +# This Library contains functions to preprocess Sentinel-2 images downloaded from +# different data hubs, such as THEIA, PEPS or SCIHUB +# == == == == == == == == == == == == == == == == == == == == == == == == == == == + +#" This function adjusts information from ENVI header +#" +#" @param dsn character. path where to store the stack +#" @param bands list. should include "bandname", and if possible "wavelength" +#" @param sensor character. Name of the sensor used to acquire the image +#" @param stretch boolean. Set TRUE to get 10% stretching at display for reflectance, mentioned in hdr only +#" +#" @return None +#" @importFrom utils read.table +#" @importFrom raster hdr raster +#" @export +adjust_envi_hdr <- function(dsn, bands, sensor = "Unknown", stretch = FALSE) { + + # Edit hdr file to add metadata + hdr <- read_envi_header(get_hdr_name(dsn)) + hdr$`band names` <- bands$bandname + if (length(bands$wavelength) == length(bands$bandname)) { + hdr$wavelength <- bands$wavelength + }else { + hdr$wavelength <- NULL + } + if (stretch == TRUE) { + hdr$`default stretch` <- "0.000000 1000.000000 linear" + } + hdr$`z plot range` <- NULL + hdr$`data ignore value` <- "-Inf" + hdr$`sensor type` <- sensor + write_envi_header(hdr = hdr, hdrpath = get_hdr_name(dsn)) + + # remove unnecessary files + file2remove <- paste(dsn, ".aux.xml", sep = "") + if (file.exists(file2remove)) file.remove(file2remove) + file2remove <- paste(dsn, ".prj", sep = "") + if (file.exists(file2remove)) file.remove(file2remove) + file2remove <- paste(dsn, ".stx", sep = "") + if (file.exists(file2remove)) file.remove(file2remove) + return(invisible()) +} + +#" This function saves reflectance files +#" +#" @param s2sat character. Sentinel-2 mission ("2A" or "2B") +#" @param tile_s2 character. S2 tile name (2 numbers + 3 letters) +#" @param dateacq_s2 double. date of acquisition +#" +#" @return s2mission character. name of the S2 mission (2A or 2B) +#" @importFrom sen2r safe_getMetadata check_scihub_connection s2_list +#" @export +check_s2mission <- function(s2sat, tile_s2, dateacq_s2) { + + # is mission already defined by user? + if (!is.null(s2sat)) { + if (s2sat == "2A") { + s2mission <- "2A" + }else if (s2sat == "2B") { + s2mission <- "2B" + }else { + message("Could not identify if image from Sentinel-2A or -2B") + message("Defining central wavelength of spectral bands based on S2A") + s2mission <- "2A" + } + }else { + message("Could not identify if image from Sentinel-2A or -2B") + message("Defining central wavelength of spectral bands based on S2A") + s2mission <- "2A" + } + return(s2mission) +} + +#" this function aims at computing directory size +#" @param path character. path for directory +#" @param recursive boolean . set T if recursive +#" +#" @return size_files numeric. size in bytes +#" - image stack +#" - path for individual band files corresponding to the stack +#" - path for vector (reprojected if needed) +#" +#" @importFrom raster raster +#" @importFrom tools file_path_sans_ext file_ext +#" @export +dir_size <- function(path, recursive = TRUE) { + stopifnot(is.character(path)) + files <- list.files(path, full.names = TRUE, recursive = recursive) + vect_size <- sapply(files, function(x) file.size(x)) + size_files <- sum(vect_size) + return(size_files) +} + +#" This function reads S2 data from L2A directories downloaded from +#" various data hubs including THEIA, PEPS & SCIHUB (SAFE format & LaSRC) +#" @param path_dir_s2 character. path for S2 directory +#" @param path_vector character. path for vector file +#" @param s2source character. type of directory format (depends on atmospheric correction: SAFE produced from Sen2Cor) +#" @param resolution numeric. buffer applied to vector file (in meters) +#" @param interpolation character. method for resampling. default = "bilinear" +#" @param fre_sre character. SRE or FRE products from THEIA +#" +#" @return listout list. +#" - image stack +#" - path for individual band files corresponding to the stack +#" - path for vector (reprojected if needed) +#" +#" @importFrom raster raster +#" @importFrom tools file_path_sans_ext file_ext +#" @export +extract_from_s2_l2a <- function(path_dir_s2, path_vector = NULL, s2source = "SAFE", + resolution = 10, interpolation = "bilinear", fre_sre = "FRE") { + # Get list of paths corresponding to S2 bands and depending on S2 directory + s2_bands <- get_s2_bands(path_dir_s2 = path_dir_s2, + s2source = s2source, + resolution = resolution, + fre_sre = fre_sre) + + if (length(s2_bands$s2bands_10m) > 0) { + rastmp <- raster::raster(s2_bands$s2bands_10m[[1]]) + } else if (length(s2_bands$s2bands_20m) > 0) { + rastmp <- raster::raster(s2_bands$s2bands_20m[[1]]) + } + # check if vector and raster share the same projection. if not, re-project vector + if (!is.null(path_vector)) { + raster_proj <- raster::projection(rastmp) + path_vector_reproj <- paste(tools::file_path_sans_ext(path_vector), "_reprojected.shp", sep = "") + path_vector <- reproject_shp(path_vector_init = path_vector, + newprojection = raster_proj, + path_vector_reproj = path_vector_reproj) + } + # Extract data corresponding to the vector footprint (if provided) & resample data if needed + if (length(s2_bands$s2bands_10m) > 0) { + stack_10m <- read_s2bands(s2_bands = s2_bands$s2bands_10m, path_vector = path_vector, + resampling = 1, interpolation = interpolation) + } + if (length(s2_bands$s2bands_20m) > 0) { + if (resolution == 10 && s2source != "LaSRC") { + resampling <- 2 + }else { + resampling <- 1 + } + stack_20m <- read_s2bands(s2_bands = s2_bands$s2bands_20m, path_vector = path_vector, + resampling = resampling, interpolation = interpolation) + } + # get full stack including 10m and 20m spatial resolution + if (length(s2_bands$s2bands_10m) > 0 && length(s2_bands$s2bands_20m) > 0) { + diffxstart <- attributes(stack_10m)$dimensions[[1]]$from - attributes(stack_20m)$dimensions[[1]]$from + diffxstop <- attributes(stack_10m)$dimensions[[1]]$to - attributes(stack_20m)$dimensions[[1]]$to + diffystart <- attributes(stack_10m)$dimensions[[2]]$from - attributes(stack_20m)$dimensions[[2]]$from + diffystop <- attributes(stack_10m)$dimensions[[2]]$to - attributes(stack_20m)$dimensions[[2]]$to + if (!diffxstop == 0) { + # size of 20m > size of 10m --> reduce 20m + # size of 10m > size of 20m --> reduce 10m + if (diffxstop > 0) { + stack_10m <- stack_10m[, 1:(dim(stack_10m)[1] - diffxstop), , ] + }else if (diffxstop < 0) { + stack_20m <- stack_20m[, 1:(dim(stack_20m)[1] + diffxstop), , ] + } + } + if (!diffystop == 0) { + if (diffystop > 0) { + stack_10m <- stack_10m[, , 1:(dim(stack_10m)[2] - diffystop), ] + }else if (diffystop < 0) { + stack_20m <- stack_20m[, , 1:(dim(stack_20m)[2] + diffystop), ] + } + } + if (!diffxstart == 0) { + if (diffxstart > 0) { + stack_20m <- stack_20m[, (1 + diffxstart):dim(stack_20m)[1], , ] + }else if (diffxstart < 0) { + stack_10m <- stack_10m[, (1 - diffxstart):dim(stack_10m)[1], , ] + } + } + if (!diffystart == 0) { + if (diffystart > 0) { + stack_20m <- stack_20m[, , (1 + diffystart):dim(stack_20m)[2], ] + }else if (diffystart < 0) { + stack_10m <- stack_10m[, , (1 - diffystart):dim(stack_10m)[2], ] + } + } + # reorder bands with increasing wavelength + s2bands <- c("B02", "B03", "B04", "B05", "B06", "B07", "B08", "B8A", "B11", "B12", "Cloud") + namebands <- c(names(s2_bands$s2bands_10m), names(s2_bands$s2bands_20m)) + reorder_bands <- match(s2bands, namebands) + namebands <- namebands[reorder_bands] + listfiles <- c(stack_10m$attr, stack_20m$attr)[reorder_bands] + + # adjust size to initial vector footprint without buffer + # --> buffer is needed in order to ensure that extraction following + # footprint of vector matches for images of different spatial resolution + # get bounding box corresponding to footprint of image or image subset + bb_xycoords <- get_bb(path_raster = listfiles[1], + path_vector = path_vector, buffer = 0) + + # prepare reading data for extent defined by bounding box + nxoff <- bb_xycoords$UL$col + nyoff <- bb_xycoords$UL$row + nxsize <- bb_xycoords$UR$col - bb_xycoords$UL$col + 1 + nysize <- bb_xycoords$LR$row - bb_xycoords$UR$row + 1 + nbufxsize <- nxsize + nbufysize <- nysize + s2_stack <- stars::read_stars(listfiles, along = "band", + RasterIO = list(nXOff = nxoff, nYOff = nyoff, + nXSize = nxsize, nYSize = nysize, + nBufXSize = nbufxsize, nBufYSize = nbufysize, + resample = "nearest_neighbour"), proxy = TRUE) + + + names(s2_stack$attr) <- namebands + }else if (length(s2_bands$s2bands_10m) > 0) { + s2_stack <- stack_10m + namebands <- names(s2_bands$s2bands_10m) + names(s2_stack$attr) <- namebands + }else if (length(s2_bands$s2bands_20m) > 0) { + s2_stack <- stack_20m + namebands <- names(s2_bands$s2bands_20m) + names(s2_stack$attr) <- namebands + } + + listout <- list("s2_stack" = s2_stack, "s2_bands" = s2_bands, "path_vector" = path_vector, + "namebands" = namebands) + return(listout) +} + +#" This function gets coordinates of a bounding box defined by a vector (optional) and a raster +#" +#" @param path_raster character. path for raster file +#" @param path_vector character. path for vector file +#" @param buffer numeric. buffer applied to vector file (in meters) +#" +#" @return bb_xycoords list. Coordinates (in pixels) of the upper/lower right/left corners of bounding box +#" @export +get_bb <- function(path_raster, path_vector = NULL, buffer = 0) { + + if (!is.null(path_vector)) { + # get bounding box with a 50m buffer in order to allow for interpolation + bb_xycoords <- get_bb_from_vector(path_raster = path_raster, + path_vector = path_vector, + buffer = buffer) + }else if (is.null(path_vector)) { + bb_xycoords <- get_bb_from_fullimage(path_raster) + } + return(bb_xycoords) +} + +#" This function gets extreme coordinates of a bounding box corresponding to a full image +#" +#" @param path_raster character. path for raster file +#" +#" @return bb_xycoords list. Coordinates (in pixels) of the upper/lower right/left corners of bounding box +#" @importFrom raster raster +#" @export +get_bb_from_fullimage <- function(path_raster) { + # get raster coordinates corresponding to Full image + rasterobj <- raster::raster(path_raster) + bb_xycoords <- list() + bb_xycoords[["UL"]] <- data.frame("row" = 1, "col" = 1) + bb_xycoords[["UR"]] <- data.frame("row" = 1, "col" = dim(rasterobj)[2]) + bb_xycoords[["LL"]] <- data.frame("row" = dim(rasterobj)[1], "col" = 1) + bb_xycoords[["LR"]] <- data.frame("row" = dim(rasterobj)[1], "col" = dim(rasterobj)[2]) + return(bb_xycoords) +} + +#" This gets bounding box corresponding to a vector from a raster (UL, UR, LL, LR corners) +#" +#" @param path_raster character. path for raster file +#" @param path_vector character. path for vector file +#" @param buffer numeric. buffer applied to vector file (in meters) +#" +#" @return bb_xycoords list. Coordinates (in pixels) of the upper/lower right/left corners of bounding box +#" @importFrom sf st_read st_bbox st_crop +#" @importFrom rgeos gbuffer bbox2SP +#" @importFrom sp SpatialPoints bbox +#" @importFrom raster projection extract extent raster +#" @importFrom methods as +#" @export +get_bb_from_vector <- function(path_raster, path_vector, buffer = 0) { + + data_raster <- raster::raster(path_raster) + # extract BB coordinates from vector + bb_vector <- rgeos::gbuffer(spgeom = as(sf::st_read(dsn = path_vector, quiet = TRUE), "Spatial"), + width = buffer, byid = TRUE) + # extract BB coordinates from raster + bb_raster <- rgeos::bbox2SP(bbox = bbox(data_raster)) + # compute intersection + intersect <- rgeos::gIntersection(bb_vector, bb_raster) + bbext <- raster::extent(intersect) + xmin <- bbext[1] + xmax <- bbext[2] + ymin <- bbext[3] + ymax <- bbext[4] + # get coordinates of bounding box corresponding to vector + corners <- list() + corners[["UR"]] <- sp::SpatialPoints(coords = cbind(xmax, ymax)) + corners[["LR"]] <- sp::SpatialPoints(coords = cbind(xmax, ymin)) + corners[["UL"]] <- sp::SpatialPoints(coords = cbind(xmin, ymax)) + corners[["LL"]] <- sp::SpatialPoints(coords = cbind(xmin, ymin)) + raster::projection(corners[["UL"]]) <- raster::projection(corners[["UR"]]) <- + raster::projection(corners[["LL"]]) <- raster::projection(corners[["LR"]]) <- + raster::projection(sf::st_read(dsn = path_vector, quiet = TRUE)) + # get coordinates for corners of bounding box + bb_xycoords <- list() + for (corner in names(corners)) { + ex_df <- as.data.frame(raster::extract(data_raster, corners[[corner]], cellnumbers = TRUE)) + colrow <- ind2sub(data_raster, ex_df$cell) + bb_xycoords[[corner]] <- data.frame("row" = colrow$row, "col" = colrow$col) + } + return(bb_xycoords) +} + +#" get hdr name from image file name, assuming it is BIL format +#" +#" @param impath path of the image +#" +#" @return corresponding hdr +#" @import tools +#" @export +get_hdr_name <- function(impath) { + if (tools::file_ext(impath) == "") { + impathhdr <- paste(impath, ".hdr", sep = "") + }else if (tools::file_ext(impath) == "bil") { + impathhdr <- gsub(".bil", ".hdr", impath) + }else if (tools::file_ext(impath) == "zip") { + impathhdr <- gsub(".zip", ".hdr", impath) + }else { + impathhdr <- paste(tools::file_path_sans_ext(impath), ".hdr", sep = "") + } + + if (!file.exists(impathhdr)) { + message("WARNING : COULD NOT FIND hdr FILE") + print(impathhdr) + message("Process may stop") + } + return(impathhdr) +} + +#" This function returns path for the spectral bands to be used +#" +#" @param path_dir_s2 character. Path for the directory containing S2 data. either L2A .SAFE S2 file or THEIA directory +#" @param s2source character. defines if data comes from SciHub as SAFE directory, from THEIA or from LaSRC +#" @param resolution numeric. spatial resolution of the final image: 10m or 20m +#" @param fre_sre character. SRE or FRE products from THEIA +#" +#" @return listbands list. contains path for spectral bands corresponding to 10m and 20m resolution +#" @export +get_s2_bands <- function(path_dir_s2, s2source = "SAFE", resolution = 10, fre_sre = "FRE") { + + if (s2source == "SAFE" || s2source == "Sen2Cor") { + listbands <- get_s2_bands_from_sen2cor(path_dir_s2 = path_dir_s2, resolution = resolution) + }else if (s2source == "THEIA") { + listbands <- get_s2_bands_from_theia(path_dir_s2 = path_dir_s2, resolution = resolution, + fre_sre = fre_sre) + }else if (s2source == "LaSRC") { + listbands <- get_s2_bands_from_lasrc(path_dir_s2 = path_dir_s2, resolution = resolution) + }else { + message("The data source (Atmospheric correction) for Sentinel-2 image is unknown") + message("Please provide S2 images from one of the following data sources:") + message("- LaSRC (atmospheric correction: LaSRC)") + message("- THEIA (atmospheric correction: MAJA)") + message("- SAFE (atmospheric correction: Sen2Cor)") + s2bands_10m <- s2bands_20m <- granule <- mtdfile <- metadata_msi <- metadata_lasrc <- NULL + listbands <- list("s2bands_10m" = s2bands_10m, "s2bands_20m" = s2bands_20m, "GRANULE" = granule, + "metadata" = mtdfile, "metadata_MSI" = metadata_msi, + "metadata_lasrc" = metadata_lasrc) + } + return(listbands) +} + +#" This function returns path for the spectral bands in SAFE / sen2Cor directory +#" +#" @param path_dir_s2 character. Path for the SAFE directory containing S2 data +#" @param resolution numeric. spatial resolution of the final image: 10m or 20m +#" +#" @return listbands list. contains path for spectral bands corresponding to 10m and 20m resolution, as well name of as granule +#" @export +get_s2_bands_from_sen2cor <- function(path_dir_s2, resolution = 10) { + # build path for all bands + if (resolution == 10) { + b10m <- c("B02", "B03", "B04", "B08") + b20m <- c("B05", "B06", "B07", "B8A", "B11", "B12") + }else { + b10m <- c() + b20m <- c("B02", "B03", "B04", "B05", "B06", "B07", "B08", "B8A", "B11", "B12") + } + # get granule directory & path for corresponding metadata XML file + granule <- list.dirs(list.dirs(path_dir_s2, recursive = FALSE)[grep(pattern = "GRANULE", + x = list.dirs(path_dir_s2, recursive = FALSE))], recursive = FALSE) + mtdfile <- file.path(granule, "MTD_TL.xml") + if (file.exists(file.path(path_dir_s2, "MTD_MSIL2A.xml"))) { + mtd_msi_file <- file.path(path_dir_s2, "MTD_MSIL2A.xml") + } else { + mtd_msi_file <- NULL + } + + # Define path for bands + s2bands_20m_dir <- file.path(granule, "IMG_DATA", "R20m") + s2bands_10m_dir <- file.path(granule, "IMG_DATA", "R10m") + s2bands_10m <- s2bands_20m <- list() + for (band in b20m) { + s2bands_20m[[band]] <- file.path(s2bands_20m_dir, list.files(s2bands_20m_dir, pattern = band)) + } + for (band in b10m) { + s2bands_10m[[band]] <- file.path(s2bands_10m_dir, list.files(s2bands_10m_dir, pattern = band)) + } + # get cloud mask + cloud <- "MSK_CLDPRB_20m" + cloud_20m_dir <- file.path(granule, "QI_DATA") + s2bands_20m[["Cloud"]] <- file.path(cloud_20m_dir, list.files(cloud_20m_dir, pattern = cloud)) + listbands <- list("s2bands_10m" = s2bands_10m, + "s2bands_20m" = s2bands_20m, + "GRANULE" = granule, + "metadata" = mtdfile, + "metadata_MSI" = mtd_msi_file, + "metadata_lasrc" = NULL) + return(listbands) +} + +#" This function returns path for the spectral bands in LaSRC directory +#" +#" @param path_dir_s2 character. Path for the SAFE directory containing S2 data +#" @param resolution numeric. spatial resolution of the final image: 10m or 20m +#" +#" @return listbands list. contains path for spectral bands corresponding to 10m and 20m resolution, as well name of as granule +#" @importFrom stringr str_subset +#" @export +get_s2_bands_from_lasrc <- function(path_dir_s2, resolution = 10) { + + # get granule directory & path for corresponding metadata XML file + granule <- path_dir_s2 + mtdfile <- file.path(granule, "MTD_TL.xml") + if (file.exists(file.path(path_dir_s2, "MTD_MSIL1C.xml"))) { + mtd_msi_file <- file.path(path_dir_s2, "MTD_MSIL1C.xml") + } else { + mtd_msi_file <- NULL + } + + # build path for all bands + b10m <- c("band2", "band3", "band4", "band5", "band6", "band7", "band8", "band8a", "band11", "band12") + b10m_standard <- c("B02", "B03", "B04", "B05", "B06", "B07", "B08", "B8A", "B11", "B12") + # Define path for bands + s2bands_10m <- s2bands_20m <- list() + for (i in 1:seq_along(b10m)) { + s2bands_10m[[b10m_standard[i]]] <- file.path(path_dir_s2, + list.files(path_dir_s2, + pattern = paste(b10m[i], ".tif", sep = ""))) + } + + # get metadata file containing offset + mtd_lasrc <- str_subset(list.files(path_dir_s2, pattern = "S2"), ".xml$") + if (file.exists(file.path(path_dir_s2, mtd_lasrc))) { + metadata_lasrc <- file.path(path_dir_s2, mtd_lasrc) + } else { + metadata_lasrc <- NULL + } + # get cloud mask + cloud <- "CLM" + s2bands_10m[["Cloud"]] <- file.path(path_dir_s2, list.files(path_dir_s2, pattern = cloud)) + listbands <- list("s2bands_10m" = s2bands_10m, + "s2bands_20m" = s2bands_20m, + "GRANULE" = granule, + "metadata" = mtdfile, + "metadata_MSI" = mtd_msi_file, + "metadata_lasrc" = metadata_lasrc) + return(listbands) +} + +#" This function returns path for the spectral bands in THEIA directory +#" +#" @param path_dir_s2 character. Path for the SAFE directory containing S2 data +#" @param resolution numeric. spatial resolution of the final image: 10m or 20m +#" @param fre_sre character. SRE or FRE products from THEIA +#" +#" @return listbands list. contains path for spectral bands corresponding to 10m and 20m resolution, as well name of as granule +#" @export +get_s2_bands_from_theia <- function(path_dir_s2, resolution = 10, fre_sre = "FRE") { + + # build path for all bands + if (resolution == 10) { + b10m <- c("B02", "B03", "B04", "B08") + b20m <- c("B05", "B06", "B07", "B8A", "B11", "B12") + } else { + b10m <- c() + b20m <- c("B02", "B03", "B04", "B05", "B06", "B07", "B08", "B8A", "B11", "B12") + } + + # get path_tile_s2 directory & path for corresponding metadata XML file + path_tile_s2 <- list.dirs(path_dir_s2, recursive = FALSE) + files_tile_s2 <- list.files(path_tile_s2, recursive = FALSE) + mtdfile <- file.path(path_tile_s2, files_tile_s2[grep(pattern = "MTD_ALL.xml", x = files_tile_s2)]) + + # Define path for bands + s2bands_10m_dir <- s2bands_20m_dir <- path_tile_s2 + s2bands_10m <- s2bands_20m <- list() + for (band in b20m) { + band_20m_pattern <- paste0(gsub("0", "", band), ".tif") # for THEAI band 2 is "B2" ("B02" for SAFE) + list_files_20m <- list.files(s2bands_20m_dir, pattern = band_20m_pattern) + s2bands_20m[[band]] <- file.path(s2bands_20m_dir, list_files_20m)[grep(pattern = fre_sre, + x = file.path(s2bands_20m_dir, list_files_20m))] + } + for (band in b10m) { + band_10m_pattern <- paste0(gsub("0", "", band), ".tif") # for THEAI band 2 is "B2" ("B02" for SAFE) + list_files_10m <- list.files(s2bands_10m_dir, pattern = band_10m_pattern) + s2bands_10m[[band]] <- file.path(s2bands_10m_dir, list_files_10m)[grep(pattern = fre_sre, + x = file.path(s2bands_10m_dir, list_files_10m))] + } + + # get cloud mask 10m + cloud_10m <- "CLM_R1" + cloud_10m_dir <- file.path(path_tile_s2, "MASKS") + s2bands_10m[["Cloud"]] <- file.path(cloud_10m_dir, list.files(cloud_10m_dir, pattern = cloud_10m)) + + # get cloud mask 20m + cloud_20m <- "CLM_R2" + cloud_20m_dir <- file.path(path_tile_s2, "MASKS") + s2bands_20m[["Cloud"]] <- file.path(cloud_20m_dir, list.files(cloud_20m_dir, pattern = cloud_20m)) + + # return list bands + listbands <- list("s2bands_10m" = s2bands_10m, + "s2bands_20m" = s2bands_20m, + "path_tile_s2" = path_tile_s2, + "metadata" = mtdfile) + return(listbands) +} + +#" This function check S2 data level: +#" - L2A: already atmospherically corrected +#" - L1C: requires atmospheric corrections with sen2cor +#" +#" @param prodname character. original name for the S2 image +#" +#" @return s2level character. S2 level: L1C or L2A +#" @export +get_s2_level <- function(prodname) { + prodname <- basename(prodname) + if (length(grep(pattern = "L1C_", x = prodname)) == 1) { + s2level <- "L1C" + } else if (length(grep(pattern = "L2A_", x = prodname)) == 1) { + s2level <- "L2A" + } + return(s2level) +} + +#" This function gets tile from S2 image +#" +#" @param prodname character. original name for the S2 image +#" +#" @return tilename character +#" @importFrom tools file_path_sans_ext +#" @export +get_tile <- function(prodname) { + prodname <- basename(prodname) + tilename <- tools::file_path_sans_ext(gsub("_.*", "", gsub(".*_T", "", prodname))) + return(tilename) +} + +#" This function gets acquisition date from S2 image +#" +#" @param prodname character. original name for the S2 image +#" +#" @return dateacq character +#" @export +get_date <- function(prodname) { + prodname <- basename(prodname) + dateacq <- as.Date(gsub("T.*", "", gsub(".*_20", "20", prodname)), format = "%Y%m%d") + return(dateacq) +} + +#" download S2 L1C data from Copernicus hub or Google cloud +#" +#" @param list_safe safe object. produced with sen2r::s2_list +#" @param l1c_path character. path for storage of L1C image +#" @param path_vector path for a vector file +#" @param time_interval dates. time interval for S2 query +#" @param googlecloud boolean. set to TRUE if google cloud SDK is installed and +#" @param forcegoogle boolean. set to TRUE if only google requested +#" sen2r configured as an alternative hub for S2 download +#" +#" @return prodname character. S2 Product name +#" @importFrom sen2r safe_is_online s2_list s2_download s2_order check_gcloud +#" @export +get_s2_l1c_image <- function(list_safe, l1c_path, path_vector, time_interval, + googlecloud = FALSE, forcegoogle = FALSE) { + # Check if available from Copernicus hub first + copernicus_avail <- sen2r::safe_is_online(list_safe) + # if available: download + prodname <- attr(list_safe, which = "name") + if (file.exists(file.path(l1c_path, prodname))) { + message("L1C file already downloaded") + message(file.path(l1c_path, prodname)) + } else { + if (copernicus_avail == TRUE && forcegoogle == FALSE) { + sen2r::s2_download(list_safe, outdir = l1c_path) + } else if (copernicus_avail == FALSE || forcegoogle == TRUE) { + # if not available and googlecloud==TRUE + if (googlecloud == TRUE) { + # check if google cloud SDK available from this computer + ggc <- sen2r::check_gcloud() + if (ggc == TRUE) { + message("downloading from Google cloud") + list_safe_ggc <- sen2r::s2_list(spatial_extent = sf::st_read(dsn = path_vector), + time_interval = time_interval, + server = "gcloud") + prodname <- attr(list_safe_ggc, which = "name") + if (file.exists(file.path(l1c_path, prodname))) { + message("L1C file already downloaded") + message(file.path(l1c_path, prodname)) + } else { + sen2r::s2_download(list_safe_ggc, outdir = l1c_path) + # check if QI_DATA exists in DATASTRIP, and create it if not the case + datastrip_path <- file.path(l1c_path, prodname, "DATASTRIP") + dsdir <- list.dirs(datastrip_path, recursive = FALSE) + if (length(match(list.dirs(dsdir, recursive = FALSE, full.names = FALSE), "QI_DATA")) == 0) { + dir.create(file.path(dsdir, "QI_DATA")) + } + } + } else if (ggc == FALSE) { + message("googlecloud set to TRUE but missing") + message("Please install Google cloud SDK") + message("https://cloud.google.com/sdk/docs/install") + message("and/or set configuration of sen2r following instructions") + message("https://www.r-bloggers.com/2021/06/downloading-sentinel-2-archives-from-google-cloud-with-sen2r/") + } + } + } + if (copernicus_avail == FALSE && googlecloud == FALSE) { + message("S2 image in Long Term Archive (LTA)") + message("Ordering image from LTA") + message("This may take 1 day, please run your script later") + orders2 <- sen2r::s2_order(list_safe) + message("An alternative is possible with Google cloud SDK") + message("https://cloud.google.com/sdk/docs/install") + message("and/or set configuration of sen2r following instructions") + message("https://www.r-bloggers.com/2021/06/downloading-sentinel-2-archives-from-google-cloud-with-sen2r/") + } + } + return(prodname) +} + +#" download S2 L2A data from Copernicus hub or convert L1C to L2A +#" +#" @param l2a_path character. path for storage of L2A image +#" @param spatial_extent path for a vector file +#" @param dateacq character. date of acquisition +#" @param deletel1c Boolean. set TRUE to delete L1C images +#" @param Sen2Cor Boolean. set TRUE to automatically perform atmospheric corrections using sen2Cor +#" @param googlecloud boolean. set to TRUE if google cloud SDK is installed and +#" sen2r configured as an alternative hub for S2 download +#" +#" @return pathl2a character. Path for L2A image +#" @importFrom sen2r s2_list s2_download +#" @importFrom R.utils getAbsolutePath + +#" @export +get_s2_l2a_image <- function(l2a_path, spatial_extent, dateacq, + deletel1c = FALSE, sen2cor = TRUE, + googlecloud = FALSE) { + + # Needs to be updated: define path for L1c data + l1c_path <- l2a_path + # define time interval + time_interval <- as.Date(c(dateacq, dateacq)) + # get list S2 products corresponding to study area and date of interest using sen2r package + if (googlecloud == TRUE) { + server <- c("scihub", "gcloud") + } else if (googlecloud == FALSE) { + server <- "scihub" + } + list_safe <- sen2r::s2_list(spatial_extent = sf::st_read(dsn = spatial_extent), + time_interval = time_interval, + server = server, availability = "check") + # download products + sen2r::s2_download(list_safe, outdir = l2a_path) + # name all products + prodname <- attr(list_safe, which = "name") + prodfullpath <- file.path(l2a_path, prodname) + if (sen2cor == TRUE) { + for (imgname in prodname) { + s2level <- get_s2_level(imgname) + if (s2level == "L1C") { + datepattern <- gsub(pattern = "-", replacement = "", x = dateacq) + pathl2a <- s2_from_l1c_to_l2a(prodname = imgname, l1c_path = l2a_path, l2a_path = l2a_path, + datepattern = datepattern, tmp_path = NULL) + if (deletel1c == TRUE) { + unlink(x = R.utils::getAbsolutePath(file.path(l1c_path, prodname)), + recursive = TRUE, force = TRUE) + # delete from full path and add atmospherically corrected + whichimg <- grep(x = prodfullpath, pattern = imgname) + dateacq <- get_date(imgname) + tilename <- get_tile(imgname) + pathl2a <- list.files(path = l2a_path, pattern = tilename, full.names = TRUE) + pathl2a <- pathl2a[grep(x = pathl2a, pattern = dateacq)] + pathl2a <- pathl2a[grep(x = basename(pathl2a), pattern = "L2A")] + prodfullpath[whichimg] <- pathl2a + } + } + } + } + + return(prodfullpath) +} + +#" convert image coordinates from index to X-Y +#" +#" @param Raster image raster object +#" @param image_index coordinates corresponding to the raster +ind2sub <- function(data_raster, image_index) { + c <- ((image_index - 1) %% data_raster@ncols) + 1 + r <- floor((image_index - 1) / data_raster@ncols) + 1 + my_list <- list("col" = c, "row" = r) + return(my_list) +} + +#" mosaicing a set of rasters +#" +#" @param list_rasters character. list of paths corresponding to rasters to mosaic +#" @param dst_mosaic character. path and name of mosaic produced +#" @param stretch boolean. Set TRUE to get 10% stretching at display for reflectance, mentioned in hdr only +#" +#" @return None +#" @importFrom gdalUtils mosaic_rasters +#" @importFrom raster hdr raster +#" @export +mosaic_rasters <- function(list_rasters, dst_mosaic, stretch = FALSE) { + + # produce mosaic + gdalUtils::mosaic_rasters(gdalfile = list_rasters, dst_dataset = dst_mosaic, + separate = FALSE, of = "Ehdr", verbose = TRUE) + + # convert hdr to ENVI format + raster::hdr(raster(dst_mosaic), format = "ENVI") + # add info to hdr based on initial rasters + hdr_init <- read_envi_header(get_hdr_name(list_rasters[1])) + hdr <- read_envi_header(get_hdr_name(dst_mosaic)) + hdr$`band names` <- hdr_init$`band names` + hdr$wavelength <- hdr_init$wavelength + if (stretch == TRUE) { + hdr$`default stretch` <- "0.000000 1000.000000 linear" + } + hdr$`z plot range` <- NULL + hdr$`data ignore value` <- "-Inf" + hdr$`sensor type` <- hdr_init$`sensor type` + hdr$`coordinate system string` <- read.table(paste(file_path_sans_ext(dst_mosaic), ".prj", sep = "")) + write_envi_header(hdr = hdr, hdrpath = get_hdr_name(dst_mosaic)) + return(invisible()) +} + +#" Reads ENVI hdr file +#" +#" @param hdrpath Path of the hdr file +#" +#" @return list of the content of the hdr file +#" @export +read_envi_header <- function(hdrpath) { + if (!grepl(".hdr$", hdrpath)) { + stop("File extension should be .hdr") + } + hdr <- readLines(hdrpath) + ## check ENVI at beginning of file + if (!grepl("ENVI", hdr[1])) { + stop("Not an ENVI header (ENVI keyword missing)") + } else { + hdr <- hdr [-1] + } + ## remove curly braces and put multi-line key-value-pairs into one line + hdr <- gsub("\\{([^}]*)\\}", "\\1", hdr) + l <- grep("\\{", hdr) + r <- grep("\\}", hdr) + + if (length(l) != length(r)) { + stop("Error matching curly braces in header (differing numbers).") + } + + if (any(r <= l)) { + stop("Mismatch of curly braces in header.") + } + + hdr[l] <- sub("\\{", "", hdr[l]) + hdr[r] <- sub("\\}", "", hdr[r]) + + for (i in rev(seq_along(l))) { + hdr <- c( + hdr [seq_len(l [i] - 1)], + paste(hdr [l [i]:r [i]], collapse = "\n"), + hdr [-seq_len(r [i])] + ) + } + + ## split key = value constructs into list with keys as names + hdr <- sapply(hdr, split_line, "=", USE.NAMES = FALSE) + names(hdr) <- tolower(names(hdr)) + + ## process numeric values + tmp <- names(hdr) %in% c( + "samples", "lines", "bands", "header offset", "data type", + "byte order", "default bands", "data ignore value", + "wavelength", "fwhm", "data gain values" + ) + hdr [tmp] <- lapply(hdr [tmp], function(x) { + as.numeric(unlist(strsplit(x, ", "))) + }) + + return(hdr) +} + +#" This function reads a list of files corresponding to S2 bands +#" S2 bands are expected to have uniform spatial resolution and footprint +#" @param s2_bands list. list of S2 bands obtained from get_s2_bands +#" @param path_vector path for a vector file +#" @param resampling numeric. resampling factor (default = 1, set to resampling = 2 to convert 20m into 10m resolution) +#" @param interpolation character. method for resampling. default = "bilinear" +#" +#" @return stack_s2 list. contains stack of S2 bands +#" +#" @importFrom stars read_stars +#" @importFrom sf st_bbox st_read st_crop +#" @export + +read_s2bands <- function(s2_bands, path_vector = NULL, + resampling = 1, interpolation = "bilinear") { + # get bounding box corresponding to footprint of image or image subset + bb_xycoords <- get_bb(path_raster = s2_bands[[1]], + path_vector = path_vector, buffer = 50) + + # prepare reading data for extent defined by bounding box + nxoff <- bb_xycoords$UL$col + nyoff <- bb_xycoords$UL$row + nxsize <- bb_xycoords$UR$col - bb_xycoords$UL$col + 1 + nysize <- bb_xycoords$LR$row - bb_xycoords$UR$row + 1 + nbufxsize <- resampling * nxsize + nbufysize <- resampling * nysize + if (resampling == 1) { + interpolation <- "nearest_neighbour" + } + # write interpolated individual bands in temp directory + tmpdir <- tempdir() + tmpfile <- list() + for (band in names(s2_bands)) { + stack_s2_tmp <- stars::read_stars(s2_bands[[band]], along = "band", + RasterIO = list(nXOff = nxoff, nYOff = nyoff, + nXSize = nxsize, nYSize = nysize, + nBufXSize = nbufxsize, nBufYSize = nbufysize, + resample = interpolation), proxy = FALSE) + if (!is.null(path_vector)) { + stack_s2_tmp <- sf::st_crop(x = stack_s2_tmp, y = st_bbox(st_read(dsn = path_vector, quiet = TRUE))) + } + tmpfile[[band]] <- file.path(tmpdir, tools::file_path_sans_ext(basename(s2_bands[[band]]))) + if (band == "Cloud") { + stars::write_stars(obj = stack_s2_tmp, dsn = tmpfile[[band]], + driver = "ENVI", type = "Byte", overwrite = TRUE) + } else { + stars::write_stars(obj = stack_s2_tmp, dsn = tmpfile[[band]], + driver = "ENVI", type = "Int16", overwrite = TRUE) + } + gc() + } + + stack_s2 <- stars::read_stars(tmpfile, along = "band", proxy = TRUE) + return(stack_s2) +} + +#" This function reads a raster stack, and gets footprint as pixel coordinates or vector file as input +#" @param path_raster character. path for raster file +#" @param path_vector character. path for vector file +#" @param bbpix list. coordinates of pixels corresponding to a bounding box +#" +#" @return starsobj stars object corresponding to raster or raster subset +#" +#" @importFrom stars read_stars +#" @importFrom sf st_bbox st_read st_crop +#" @export +read_raster <- function(path_raster, path_vector = NULL, bbpix = NULL) { + # get bounding box corresponding to footprint of image or image subset + if (is.null(bbpix)) { + bb_xycoords <- get_bb(path_raster = path_raster, + path_vector = path_vector, buffer = 0) + } else { + bb_xycoords <- bbpix + } + # prepare reading data for extent defined by bounding box + nxoff <- bb_xycoords$UL$col + nyoff <- bb_xycoords$UL$row + nxsize <- bb_xycoords$UR$col - bb_xycoords$UL$col + 1 + nysize <- bb_xycoords$LR$row - bb_xycoords$UR$row + 1 + nbufxsize <- nxsize + nbufysize <- nysize + starsobj <- stars::read_stars(path_raster, along = "band", + RasterIO = list(nXOff = nxoff, nYOff = nyoff, + nXSize = nxsize, nYSize = nysize, + nBufXSize = nbufxsize, nBufYSize = nbufysize), + proxy = FALSE) + return(starsobj) +} + +#" This function reprojects a shapefile and saves reprojected shapefile +#" +#" @param path_vector_init character. path for a shapefile to be reprojected +#" @param newprojection character. projection to be applied to path_vector_init +#" @param path_vector_reproj character. path for the reprojected shapefile +#" +#" @return path_vector character. path of the shapefile +#" - path_vector_init if the vector did not need reprojection +#" - path_vector_reproj if the vector needed reprojection +#" +#" @importFrom rgdal readOGR writeOGR +#" @importFrom sp spTransform +#" @importFrom raster projection +#" @export +reproject_shp <- function(path_vector_init, newprojection, path_vector_reproj) { + + dir_vector_init <- dirname(path_vector_init) + # shapefile extension + fileext <- file_ext(basename(path_vector_init)) + if (fileext == "shp") { + name_vector_init <- file_path_sans_ext(basename(path_vector_init)) + vector_init_ogr <- rgdal::readOGR(dir_vector_init, name_vector_init, verbose = FALSE) + } else if (fileext == "kml") { + vector_init_ogr <- rgdal::readOGR(path_vector_init, verbose = FALSE) + } + vector_init_proj <- raster::projection(vector_init_ogr) + + if (!vector_init_proj == newprojection) { + dir_vector_reproj <- dirname(path_vector_reproj) + name_vector_reproj <- file_path_sans_ext(basename(path_vector_reproj)) + vector_reproj <- sp::spTransform(vector_init_ogr, newprojection) + rgdal::writeOGR(obj = vector_reproj, dsn = dir_vector_reproj, layer = name_vector_reproj, + driver = "ESRI Shapefile", overwrite_layer = TRUE) + path_vector <- path_vector_reproj + } else { + path_vector <- path_vector_init + } + return(path_vector) +} + + +#" perform atmospheric corrections to convert L1C to L2A data with Sen2cor +#" +#" @param prodname character. produced with sen2r::s2_list +#" @param l1c_path character. path of directory where L1C image is stored +#" @param l2a_path character. path of directory where L2A image is stored +#" @param datepattern character. pattern corresponding to date of acquisition to identify L2A directory +#" @param tmp_path character. path of temporary directory where L2A image is stored +#" sen2r configured as an alternative hub for S2 download +#" +#" @return pathl2a character. S2 Product name +#" @importFrom sen2r safe_is_online s2_list s2_download s2_order +#" @importFrom R.utils getAbsolutePath +#" +#" @export +s2_from_l1c_to_l2a <- function(prodname, l1c_path, l2a_path, datepattern, tmp_path = NULL) { + + # define path for tmp directory + if (is.null(tmp_path)) { + tmp_path <- tempdir(check = TRUE) + } + tmp_prodlist <- prodname + # perform Sen2Cor atmospheric corrections + binpath <- sen2r::load_binpaths() + # 2- open a command prompt and directly run sen2cor with following command line + cmd <- paste(binpath$sen2cor, + "--output_dir", R.utils::getAbsolutePath(l2a_path), + R.utils::getAbsolutePath(file.path(l1c_path, prodname)), sep = " ") + system(cmd) + pathl2a <- list.files(path = l2a_path, pattern = datepattern, full.names = TRUE) + + return(pathl2a) +} + +#" This function saves cloud masks. +#" "cloudMask_Binary" is default binary mask with 0 where clouds are detected and 1 for clean pixels +#" "cloudMask_RAW" is the original cloud layer produced by atmospheric correction algorithm +#" --> may be useful to refine cloud mask +#" +#" @param s2_stars list. stars object containing raster data. Can be produced with function extract_from_s2_l2a +#" @param cloud_path character. +#" @param s2source character. +#" @param footprint character. path for vector file defining footprint of interest in the image +#" @param saveraw boolean. should the original cloud mask layer be saved? +#" @param maxchunk numeric. Size of individual chunks to be written (in Mb) +#" +#" @return list of cloudmasks (binary mask, and raw mask if required) +#" @importFrom sf st_read +#" @importFrom stars write_stars +#" @importFrom raster raster +#" @export +save_cloud_s2 <- function(s2_stars, cloud_path, s2source = "SAFE", + footprint = NULL, saveraw = FALSE, maxchunk = 256) { + + whichcloud <- which(names(s2_stars$attr) == "Cloud") + # Save cloud mask + if (saveraw == TRUE) { + cloudraw <- file.path(cloud_path, "CloudMask_RAW") + obj <- stars::read_stars(s2_stars$attr[whichcloud], proxy = TRUE) + sizeobj <- dim(obj)[1] * dim(obj)[2] / (1024**2) + nbchunks <- ceiling(sizeobj / maxchunk) + stars::write_stars(obj, + dsn = cloudraw, + driver = "ENVI", + type = "Byte", + chunk_size = c(dim(obj)[1], dim(obj)[2] / nbchunks), + progress = TRUE) + } else { + cloudraw <- NULL + } + # Save cloud mask as in biodivMapR (0 = clouds, 1 = pixel ok) + cloudmask <- stars::read_stars(s2_stars$attr[whichcloud], proxy = FALSE) + if (s2source == "SAFE" || s2source == "THEIA") { + cloudy <- which(cloudmask[[1]] > 0) + sunny <- which(cloudmask[[1]] == 0) + } else if (s2source == "LaSRC") { + cloudy <- which(is.na(cloudmask[[1]])) + sunny <- which(cloudmask[[1]] == 1) + } + + cloudmask[[1]][cloudy] <- 0 + cloudmask[[1]][sunny] <- 1 + cloudbin <- file.path(cloud_path, "CloudMask_Binary") + stars::write_stars(cloudmask, dsn = cloudbin, driver = "ENVI", type = "Byte", overwrite = TRUE) + cloudmasks <- list("BinaryMask" = cloudbin, "RawMask" = cloudraw) + # delete temporary file + file.remove(s2_stars$attr[whichcloud]) + if (file.exists(paste(s2_stars$attr[whichcloud], ".hdr", sep = ""))) file.remove(paste(s2_stars$attr[whichcloud], ".hdr", sep = "")) + gc() + return(cloudmasks) +} + +#" This function saves reflectance files +#" +#" @param s2_stars list. stars object containing raster data. Can be produced with function extract_from_s2_l2a +#" @param refl_path character. path for reflectance file to be stored +#" @param format character. file format for reflectance data +#" @param datatype character. data type (integer, float, 16bits, 32bits...) +#" @param s2sat character. Sentinel-2 mission ("2A" or "2B") +#" @param tile_s2 character. S2 tile name (2 numbers + 3 letters) +#" @param dateacq_s2 double. date of acquisition +#" @param MTD character. path for metadata file +#" @param MTD_MSI character. path for metadata MSI file +#" @param mtd_lasrc character. path for metadata LaSRC file +#" @param maxchunk numeric. Size of individual chunks to be written (in Mb) +#" +#" @return None +#" @importFrom stars write_stars st_apply +#" @importFrom XML xml +#" @export +save_reflectance_s2 <- function(s2_stars, refl_path, format = "ENVI", datatype = "Int16", + s2sat = NULL, tile_s2 = NULL, dateacq_s2 = NULL, + mtd = NULL, mtd_msi = NULL, mtd_lasrc = NULL, + maxchunk = 256) { + # identify if S2A or S2B, if possible + s2mission <- check_s2mission(s2sat = s2sat, tile_s2 = tile_s2, dateacq_s2 = dateacq_s2) + + # define central wavelength corresponding to each spectral band + if (s2mission == "2A") { + wl_s2 <- list("B02" = 496.6, "B03" = 560.0, "B04" = 664.5, + "B05" = 703.9, "B06" = 740.2, "B07" = 782.5, "B08" = 835.1, + "B8A" = 864.8, "B11" = 1613.7, "B12" = 2202.4) + } else if (s2mission == "2B") { + wl_s2 <- list("B02" = 492.1, "B03" = 559.0, "B04" = 665.0, + "B05" = 703.8, "B06" = 739.1, "B07" = 779.7, "B08" = 833.0, + "B8A" = 864.0, "B11" = 1610.4, "B12" = 2185.7) + } + if (s2mission == "2A") { + sensor <- "Sentinel_2A" + } else if (s2mission == "2B") { + sensor <- "Sentinel_2B" + } + + # apply offset when necessary + listbands_bis <- c("B2", "B3", "B4", "B5", "B6", "B7", "B8", "B8A", "B11", "B12") + if (!is.null(mtd_msi) && is.null(mtd_lasrc)) { + # read XML file containing info about geometry of acquisition + s2xml <- XML::xmlToList(mtd_msi) + xml_offset <- s2xml$General_Info$Product_Image_Characteristics$BOA_ADD_offset_VALUES_LIST + bands <- lapply(s2xml$General_Info$Product_Image_Characteristics$Spectral_Information_List, "[[", 4) + if (!is.null(xml_offset) && !is.null(bands)) { + bandid <- lapply(bands, "[[", 1) + bandname <- lapply(bands, "[[", 2) + offset <- data.frame("bandname" = unlist(bandname), + "bandid" = unlist(bandid), + "offset" = unlist(lapply(xml_offset, "[[", 1))) + selbands <- match(listbands_bis, offset$bandname) + offset <- offset[selbands, ] + boa_quantval <- as.numeric(s2xml$General_Info$Product_Image_Characteristics$QUANTIFICATION_VALUES_LIST$BOA_QUANTIFICATION_VALUE[1]) + } else { + offset <- data.frame("bandname" = listbands_bis, + "bandid" = c(1, 2, 3, 4, 5, 6, 7, 8, 11, 12), + "offset" = 0) + boa_quantval <- 10000 + } + } else if (!is.null(mtd_lasrc)) { + # read XML file containing info about geometry of acquisition + s2xml <- XML::xmlToList(mtd_lasrc) + attributes_lasrc <- s2xml$bands[[14]]$.attrs + attributes_lasrc_df <- data.frame(attributes_lasrc) + if (match("add_offset", rownames(attributes_lasrc_df)) > 0 && match("scale_factor", rownames(attributes_lasrc_df)) > 0) { + xml_offset <- as.numeric(attributes_lasrc[["add_offset"]]) + boa_quantval <- 1 / as.numeric(attributes_lasrc[["scale_factor"]]) + offset <- data.frame("bandname" = listbands_bis, + "bandid" = c(1, 2, 3, 4, 5, 6, 7, 8, 11, 12), + "offset" = xml_offset) + } else { + offset <- data.frame("bandname" = listbands_bis, + "bandid" = c(1, 2, 3, 4, 5, 6, 7, 8, 11, 12), + "offset" = 0) + boa_quantval <- 10000 + } + } else { + offset <- data.frame("bandname" = listbands_bis, + "bandid" = c(1, 2, 3, 4, 5, 6, 7, 8, 11, 12), + "offset" = 0) + boa_quantval <- 10000 + } + + # identify where spectral bands are in the stars object + stars_spectral <- list() + starsnames <- names(s2_stars$attr) + stars_spectral$bandname <- starsnames[which(!starsnames == "Cloud")] + stars_spectral$wavelength <- wl_s2[stars_spectral$bandname] + + sortedwl <- names(wl_s2) + reorder <- match(sortedwl, stars_spectral$bandname) + elim <- which(is.na(reorder)) + if (length(elim) > 0) { + reorder <- reorder[-elim] + } + pathr <- s2_stars$attr[reorder] + + names(pathr) <- NULL + s2_stars2 <- stars::read_stars(pathr, along = "band", proxy = TRUE) + stars_spectral$bandname <- stars_spectral$bandname[reorder] + stars_spectral$wavelength <- stars_spectral$wavelength[reorder] + + uniqueoffset <- as.numeric(unique(offset$offset)) + if (length(uniqueoffset) > 1) { + message("Warning: BOA offset differs between bands.") + message("offset will not be applied to the final S2 reflectance raster") + message("check metadata file to identify the offset applied on each band") + print(mtd_msi) + } else { + message("applying offset to reflectance data") + if (is.null(mtd_lasrc) || uniqueoffset == 0) { + offsets2 <- function(x) (round(x + uniqueoffset) * (10000 / boa_quantval)) + s2_stars2 <- stars::st_apply(X = s2_stars2, MARGIN = "band", FUN = offsets2) + } else { + offsets2 <- function(x) (round(10000 * ((x + uniqueoffset * boa_quantval) / boa_quantval))) + s2_stars2 <- stars::st_apply(X = s2_stars2, MARGIN = "band", FUN = offsets2) + } + } + write_stack_s2(stars_s2 = s2_stars2, stars_spectral = stars_spectral, refl_path = refl_path, + format = format, datatype = datatype, sensor = sensor, maxchunk = maxchunk) + # save metadata file as well if available + if (!is.null(mtd)) { + if (file.exists(mtd)) { + file.copy(from = mtd, to = file.path(dirname(refl_path), basename(mtd)), overwrite = TRUE) + } + } + # save metadata file as well if available + if (!is.null(mtd_msi)) { + if (file.exists(mtd_msi)) { + file.copy(from = mtd_msi, to = file.path(dirname(refl_path), basename(mtd_msi)), overwrite = TRUE) + } + } + # save LaSRC metadata file as well if available + if (!is.null(mtd_lasrc)) { + if (file.exists(mtd_lasrc)) { + file.copy(from = mtd_lasrc, to = file.path(dirname(refl_path), basename(mtd_lasrc)), overwrite = TRUE) + } + } + # delete temporary file + for (pathtemp in pathr) { + file.remove(pathtemp) + if (file.exists(paste(pathtemp, ".hdr", sep = ""))) file.remove(paste(pathtemp, ".hdr", sep = "")) + } + gc() + return(invisible()) +} + +#" ENVI functions +#" +#" based on https://github.com/cran/hyperSpec/blob/master/R/read.ENVI.R +#" added wavelength, fwhm, ... to header reading +#" Title +#" +#" @param x character. +#" @param separator character +#" @param trim_blank boolean. +#" +#" @return list. +#" @export +split_line <- function(x, separator, trim_blank = TRUE) { + tmp <- regexpr(separator, x) + key <- substr(x, 1, tmp - 1) + value <- substr(x, tmp + 1, nchar(x)) + if (trim_blank) { + blank_pattern <- "^[[:blank:]]*([^[:blank:]]+.*[^[:blank:]]+)[[:blank:]]*$" + key <- sub(blank_pattern, "\\1", key) + value <- sub(blank_pattern, "\\1", value) + } + value <- as.list(value) + names(value) <- key + return(value) +} + +#" save raster footprint as vector file +#" +#" @param path_raster character. path for a raster file +#" @param path_vector character. path for a vector file +#" @param driver character. driver for vector +#" +#" @return None +#" @importFrom raster raster extent projection +#" @importFrom sf st_as_sf st_write +#" @export +vectorize_raster_extent <- function(path_raster, path_vector, driver = "ESRI Shapefile") { + rast <- raster(path_raster) + e <- extent(rast) + # coerce to a SpatialPolygons object + p <- as(e, "SpatialPolygons") + projection(p) <- projection(rast) + p <- sf::st_as_sf(p) + sf::st_write(obj = p, path_vector, driver = driver) # create to a shapefile + return(invisible()) +} + +#" writes ENVI hdr file +#" +#" @param hdr content to be written +#" @param hdrpath Path of the hdr file +#" +#" @return None +#" @importFrom stringr str_count +#" @export +write_envi_header <- function(hdr, hdrpath) { + h <- lapply(hdr, function(x) { + if (length(x) > 1 || (is.character(x) && stringr::str_count(x, "\\w+") > 1)) { + x <- paste0("{", paste(x, collapse = ", "), "}") + } + # convert last numerics + x <- as.character(x) + }) + writeLines(c("ENVI", paste(names(hdr), h, sep = " = ")), con = hdrpath) + return(invisible()) +} + +#" This function writes a raster Stack object into a ENVI raster file +#" +#" @param stackobj list. raster stack +#" @param stackpath character. path where to store the stack +#" @param bands list. should include "bandname", and if possible "wavelength" +#" @param datatype character. should be INT2S or FLT4S for example +#" @param sensor character. Name of the sensor used to acquire the image +#" @param stretch boolean. Set TRUE to get 10% stretching at display for reflectance, mentioned in hdr only +#" +#" @return None +#" @importFrom utils read.table +#" @export +write_rasterstack_envi <- function(stackobj, stackpath, bands, datatype = "INT2S", + sensor = "Unknown", stretch = FALSE) { + + r <- raster::writeRaster(x = stackobj, filename = stackpath, format = "Ehdr", overwrite = TRUE, datatype = datatype) + raster::hdr(r, format = "ENVI") + # Edit hdr file to add metadata + hdr <- read_envi_header(get_hdr_name(stackpath)) + hdr$`band names` <- bands$bandname + if (length(bands$wavelength) == length(bands$bandname)) { + hdr$wavelength <- bands$wavelength + } else { + hdr$wavelength <- NULL + } + if (stretch == TRUE) { + hdr$`default stretch` <- "0.000000 1000.000000 linear" + } + hdr$`z plot range` <- NULL + hdr$`data ignore value` <- "-Inf" + hdr$`coordinate system string` <- read.table(paste(stackpath, ".prj", sep = "")) + proj <- strsplit(x = strsplit(x = projection(stackobj), split = " ")[[1]][1], split = "=")[[1]][2] + zone <- strsplit(x = strsplit(x = projection(stackobj), split = " ")[[1]][2], split = "=")[[1]][2] + datum <- strsplit(x = strsplit(x = projection(stackobj), split = " ")[[1]][3], split = "=")[[1]][2] + oldproj <- hdr$`map info` + newproj <- gsub(pattern = "projection", replacement = proj, x = oldproj) + newproj <- paste(newproj, zone, datum, sep = ", ") + hdr$`map info` <- newproj + hdr$`sensor type` <- sensor + write_envi_header(hdr = hdr, hdrpath = get_hdr_name(stackpath)) + + # remove unnecessary files + file2remove <- paste(stackpath, ".aux.xml", sep = "") + file.remove(file2remove) + file2remove <- paste(stackpath, ".prj", sep = "") + file.remove(file2remove) + file2remove <- paste(stackpath, ".stx", sep = "") + file.remove(file2remove) + return(invisible()) +} + + +#" This function writes a stars object into a raster file +#" +#" @param stars_s2 list. stars object containing raster data. Can be produced with function Crop_n_resample_S2 +#" @param stars_spectral list. band name to be saved in the stack and spectral bands corresponding to the image +#" @param refl_path character. path where to store the image +#" @param format character. default = ENVI BSQ. otherwise use gdal drivers +#" @param datatype character. should be Int16 or Float64 for example +#" @param sensor character. Name of the sensor used to acquire the image +#" @param maxchunk numeric. Size of individual chunks to be written (in Mb) +#" +#" @return None +#" @export +write_stack_s2 <- function(stars_s2, stars_spectral, refl_path, format = "ENVI", + datatype = "Int16", sensor = "Unknown", maxchunk = 256) { + + # write raster file from proxy using chunks + sizeobj <- 2 * dim(stars_s2)[1] * dim(stars_s2)[2] * dim(stars_s2)[3] / (1024**2) + nbchunks <- ceiling(sizeobj / maxchunk) + stars::write_stars(obj = stars_s2, + dsn = refl_path, + driver = format, + type = datatype, + chunk_size = c(dim(stars_s2)[1], ceiling(dim(stars_s2)[2] / nbchunks)), + progress = TRUE) + + if (format == "ENVI") { + adjust_envi_hdr(dsn = refl_path, bands = stars_spectral, + sensor = sensor, stretch = TRUE) + } + return(invisible()) +} diff -r 000000000000 -r 33a1e15f7252 alpha_beta.r --- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/alpha_beta.r Mon Jan 09 13:37:05 2023 +0000 @@ -0,0 +1,142 @@ +#Rscript + +########################################### +## Mapping alpha and beta diversity ## +########################################### + +#####Packages : stars +# utils +# biodivmapr +# raster +# sf +# mapview +# leafpop +# RColorBrewer +# labdsv +# rgdal +# ggplot2 +# gridExtra + +#####Load arguments + +args <- commandArgs(trailingOnly = TRUE) + +#####Import the S2 data + +if (length(args) < 1) { + stop("This tool needs at least 1 argument") +}else { + data_raster <- args[1] + rasterheader <- args[2] + data <- args[3] + # type of PCA: + # PCA: no rescaling of the data + # SPCA: rescaling of the data + typepca <- as.character(args[4]) + alpha <- as.logical(args[5]) + beta <- as.logical(args[6]) + funct <- as.logical(args[7]) + all <- as.logical(args[8]) + nbcpu <- as.integer(args[9]) + source(args[10]) +} + +################################################################################ +## DEFINE PARAMETERS FOR DATASET TO BE PROCESSED ## +################################################################################ +if (data_raster == "") { + #Create a directory where to unzip your folder of data + dir.create("data_dir") + unzip(data, exdir = "data_dir") + # Path to raster + data_raster <- list.files("data_dir/results/Reflectance", pattern = "_Refl") + input_image_file <- file.path("data_dir/results/Reflectance", data_raster[1]) + input_header_file <- file.path("data_dir/results/Reflectance", data_raster[2]) + +} else { + input_image_file <- file.path(getwd(), data_raster, fsep = "/") + input_header_file <- file.path(getwd(), rasterheader, fsep = "/") +} + +################################################################################ +## PROCESS IMAGE ## +################################################################################ +# 1- Filter data in order to discard non vegetated / shaded / cloudy pixels + +print("PERFORM PCA ON RASTER") +pca_output <- biodivMapR::perform_PCA(Input_Image_File = input_image_file, Input_Mask_File = input_mask_file, + Output_Dir = output_dir, TypePCA = typepca, FilterPCA = filterpca, nbCPU = nbcpu, MaxRAM = maxram) + +pca_files <- pca_output$PCA_Files +pix_per_partition <- pca_output$Pix_Per_Partition +nb_partitions <- pca_output$nb_partitions +# path for the updated mask +input_mask_file <- pca_output$MaskPath + + +selected_pcs <- seq(1, dim(raster::stack(input_image_file))[3]) + +selected_pcs <- all(selected_pcs) +################################################################################ +## MAP ALPHA AND BETA DIVERSITY ## +################################################################################ +print("MAP SPECTRAL SPECIES") + +kmeans_info <- biodivMapR::map_spectral_species(Input_Image_File = input_image_file, Output_Dir = output_dir, PCA_Files = pca_files, Input_Mask_File = input_mask_file, SelectedPCs = selected_pcs, Pix_Per_Partition = pix_per_partition, nb_partitions = nb_partitions, TypePCA = typepca, nbCPU = nbcpu, MaxRAM = maxram, nbclusters = nbclusters) + +image_name <- tools::file_path_sans_ext(basename(input_image_file)) +if (alpha == TRUE || beta == TRUE || all == TRUE) { +## alpha + print("MAP ALPHA DIVERSITY") + index_alpha <- c("Shannon") + alpha_div <- biodivMapR::map_alpha_div(Input_Image_File = input_image_file, Output_Dir = output_dir, TypePCA = typepca, window_size = window_size, nbCPU = nbcpu, MaxRAM = maxram, Index_Alpha = index_alpha, nbclusters = nbclusters, FullRes = TRUE, LowRes = FALSE, MapSTD = FALSE) + + alpha_zip <- file.path(output_dir, image_name, typepca, "ALPHA", "Shannon_10_Fullres.zip") + alpha_path <- file.path(output_dir, image_name, typepca, "ALPHA") + unzip(alpha_zip, exdir = alpha_path) + alpha_path <- file.path(output_dir, image_name, typepca, "ALPHA", "Shannon_10_Fullres") + alpha_raster <- raster::raster(alpha_path) + get_alpha <- convert_raster(alpha_raster) + + if (alpha == TRUE || all == TRUE) { + colnames(get_alpha) <- c("Alpha", "longitude", "latitude") + plot_indices(get_alpha, titre = "Alpha") + + write.table(get_alpha, file = "alpha.tabular", sep = "\t", dec = ".", na = " ", row.names = FALSE, col.names = TRUE, quote = FALSE) +} + if (beta == TRUE || all == TRUE) { +## beta + print("MAP BETA DIVERSITY") + beta_div <- biodivMapR::map_beta_div(Input_Image_File = input_image_file, Output_Dir = output_dir, TypePCA = typepca, window_size = window_size, nb_partitions = nb_partitions, nbCPU = nbcpu, MaxRAM = maxram, nbclusters = nbclusters) + + beta_path <- file.path(output_dir, image_name, typepca, "BETA", "BetaDiversity_BCdiss_PCO_10") + beta_raster <- raster::raster(beta_path) + get_beta <- convert_raster(beta_raster) + + colnames(get_beta) <- c("Beta", "longitude", "latitude") + plot_indices(get_beta, titre = "Beta") + + write.table(get_beta, file = "beta.tabular", sep = "\t", dec = ".", na = " ", row.names = FALSE, col.names = TRUE, quote = FALSE) + } +} + + +################################################################################ +## COMPUTE ALPHA AND BETA DIVERSITY FROM FIELD PLOTS ## +################################################################################ + +if (funct == TRUE || all == TRUE) { + mapper <- biodivMapR::map_functional_div(Original_Image_File = input_image_file, Functional_File = pca_files, Selected_Features = selected_pcs, Output_Dir = output_dir, window_size = window_size, nbCPU = nbcpu, MaxRAM = maxram, TypePCA = typepca, FullRes = TRUE, LowRes = FALSE, MapSTD = FALSE) + + funct_zip <- file.path(output_dir, image_name, typepca, "FUNCTIONAL", "FunctionalDiversity_Map_MeanFilter_Fullres.zip") + funct_path <- file.path(output_dir, image_name, typepca, "FUNCTIONAL") + unzip(funct_zip, exdir = funct_path) + funct_path <- file.path(output_dir, image_name, typepca, "FUNCTIONAL", "FunctionalDiversity_Map_MeanFilter_Fullres") + funct_raster <- raster::raster(funct_path) + get_funct <- convert_raster(funct_raster) + + colnames(get_funct) <- c("Functionnal", "longitude", "latitude") + plot_indices(get_funct, titre = "Functionnal") + + write.table(get_funct, file = "Functionnal.tabular", sep = "\t", dec = ".", na = " ", row.names = FALSE, col.names = TRUE, quote = FALSE) +} diff -r 000000000000 -r 33a1e15f7252 biodiv_indices_global.r --- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/biodiv_indices_global.r Mon Jan 09 13:37:05 2023 +0000 @@ -0,0 +1,112 @@ +#Rscript + +########################################### +## Mapping biodiversity indicators ## +########################################### + +#####Packages : raster, +# rgdal, +# sp, +# rasterdiv, +# ggplot2, + +#####Load arguments + +args <- commandArgs(trailingOnly = TRUE) + +#####Import the S2 data + +if (length(args) < 1) { + stop("This tool needs at least 1 argument") +}else { + data_raster <- args[1] + data_header <- args[2] + data <- args[3] + alpha <- as.numeric(args[4]) + source(args[5]) + +} + +######################################################################## +## COMPUTE BIODIVERSITY INDICES ## +######################################################################## + +if (data_raster == "") { + #Create a directory where to unzip your folder of data + dir.create("data_dir") + unzip(data, exdir = "data_dir") + # Path to raster + data_raster <- list.files("data_dir/results/Reflectance", pattern = "_Refl") + data_raster <- file.path("data_dir/results/Reflectance", data_raster[1]) +} + +# Read raster +copndvi <- raster::raster(data_raster) + +copndvilr <- raster::reclassify(copndvi, cbind(252, 255, NA), right = TRUE) + +#Resample using raster::aggregate and a linear factor of 10 +copndvilr <- raster::aggregate(copndvilr, fact = 20) +#Set float numbers as integers to further speed up the calculation +storage.mode(copndvilr[]) <- "integer" + +# Convert raster to SpatialPointsDataFrame +r_pts <- convert_raster(copndvilr) + +#Shannon's Diversity +sha <- rasterdiv::Shannon(copndvilr, window = 9, np = 1) +sha_df <- data.frame(raster::rasterToPoints(sha, spatial = TRUE)) +sha_name <- "Shannon" +r_pts[, sha_name] <- sha_df[, 1] + +#Renyi's Index +ren <- rasterdiv::Renyi(copndvilr, window = 9, alpha = alpha, np = 1) +ren_df <- data.frame(raster::rasterToPoints(ren[[1]])) +ren_name <- "Renyi" +r_pts[, ren_name] <- ren_df[, 3] + +#Berger-Parker's Index +ber <- rasterdiv::BergerParker(copndvilr, window = 9, np = 1) +ber_df <- data.frame(raster::rasterToPoints(ber, spatial = TRUE)) +ber_name <- "Berger-Parker" +r_pts[, ber_name] <- ber_df[, 1] + +#Pielou's Evenness +pie <- rasterdiv::Pielou(copndvilr, window = 9, np = 1) +pie_df <- data.frame(raster::rasterToPoints(pie)) +if (length(pie_df[, 1]) == length(r_pts[, 1])) { + pie_name <- "Pielou" + r_pts[, pie_name] <- pie_df[, 1] +} + +#Hill's numbers +hil <- rasterdiv::Hill(copndvilr, window = 9, alpha = alpha, np = 1) +hil_df <- data.frame(raster::rasterToPoints(hil[[1]])) +hil_name <- "Hill" +r_pts[, hil_name] <- hil_df[, 3] + +#Parametric Rao's quadratic entropy with alpha ranging from 1 to 5 +prao <- rasterdiv::paRao(copndvilr, window = 9, alpha = alpha, dist_m = "euclidean", np = 1) +prao_df <- data.frame(raster::rasterToPoints(prao$window.9[[1]])) +prao_name <- "Prao" +r_pts[, prao_name] <- prao_df[, 3] + +#Cumulative Residual Entropy +cre <- rasterdiv::CRE(copndvilr, window = 9, np = 1) +cre_df <- data.frame(raster::rasterToPoints(cre)) +if (length(cre_df[, 1]) == length(r_pts[, 1])) { + cre_name <- "CRE" + r_pts[, cre_name] <- cre_df[, 1] +} + +if (length(cre_df[, 1]) == length(r_pts[, 1]) || length(pie_df[, 1]) == length(r_pts[, 1])) { +list_indice <- list("Shannon", "Renyi", "Berger-Parker", "Pielou", "Hill", "Prao", "CRE") +} else { +list_indice <- list("Shannon", "Renyi", "Berger-Parker", "Hill", "Prao") +} +## Plotting all the graph and writing a tabular +for (indice in list_indice) { + plot_indices(data = r_pts, titre = indice) +} + +write.table(r_pts, file = "BiodivIndex.tabular", sep = "\t", dec = ".", na = " ", row.names = FALSE, col.names = TRUE, quote = FALSE) diff -r 000000000000 -r 33a1e15f7252 comparison_div.r --- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/comparison_div.r Mon Jan 09 13:37:05 2023 +0000 @@ -0,0 +1,190 @@ +#Rscript + +########################################### +## Mapping alpha and beta diversity ## +########################################### + +#####Packages : stars +# utils +# biodivmapr +# raster +# sf +# mapview +# leafpop +# RColorBrewer +# labdsv +# rgdal +# ggplot2 +# gridExtra +##remotes::install_github("jbferet/biodivMapR") +#####Load arguments + +args <- commandArgs(trailingOnly = TRUE) + +#####Import the S2 data + +if (length(args) < 1) { + stop("This tool needs at least 1 argument") +}else { + data_raster <- args[1] + rasterheader <- args[2] + data <- args[3] + plots_zip <- args[4] + choice <- as.character(args[5]) + source(args[6]) + # type of PCA: + # PCA: no rescaling of the data + # SPCA: rescaling of the data + typepca <- as.character(args[7]) +} + +################################################################################ +## DEFINE PARAMETERS FOR DATASET TO BE PROCESSED ## +################################################################################ +if (data_raster == "") { + #Create a directory where to unzip your folder of data + dir.create("data_dir") + unzip(data, exdir = "data_dir") + # Path to raster + data_raster <- list.files("data_dir/results/Reflectance", pattern = "_Refl") + input_image_file <- file.path("data_dir/results/Reflectance", data_raster[1]) + input_header_file <- file.path("data_dir/results/Reflectance", data_raster[2]) + +} else { + input_image_file <- file.path(getwd(), data_raster, fsep = "/") + input_header_file <- file.path(getwd(), rasterheader, fsep = "/") +} + +################################################################################ +## PROCESS IMAGE ## +################################################################################ +# 1- Filter data in order to discard non vegetated / shaded / cloudy pixels + +print("PERFORM PCA ON RASTER") +pca_output <- biodivMapR::perform_PCA(Input_Image_File = input_image_file, Input_Mask_File = input_mask_file, + Output_Dir = output_dir, TypePCA = typepca, FilterPCA = filterpca, nbCPU = nbcpu, MaxRAM = maxram) + +pca_files <- pca_output$PCA_Files +pix_per_partition <- pca_output$Pix_Per_Partition +nb_partitions <- pca_output$nb_partitions +# path for the updated mask +input_mask_file <- pca_output$MaskPath + +# 3- Select principal components from the PCA raster +# Select components from the PCA/SPCA/MNF raster +sel_compo <- c("1\n", "2\n", "3\n", "4\n", "5\n", "6\n", "7\n", "8") +image_name <- tools::file_path_sans_ext(basename(input_image_file)) +output_dir_full <- file.path(output_dir, image_name, typepca, "PCA") + +write.table(sel_compo, paste0(output_dir_full, "/Selected_Components.txt")) +sel_pc <- file.path(output_dir_full, "Selected_Components.txt") + + +################################################################################ +## MAP ALPHA AND BETA DIVERSITY ## +################################################################################ +print("MAP SPECTRAL SPECIES") + +kmeans_info <- biodivMapR::map_spectral_species(Input_Image_File = input_image_file, Output_Dir = output_dir, PCA_Files = pca_files, Input_Mask_File = input_mask_file, Pix_Per_Partition = pix_per_partition, nb_partitions = nb_partitions, nbCPU = nbcpu, MaxRAM = maxram, nbclusters = nbclusters, TypePCA = typepca) + +################################################################################ +## COMPUTE ALPHA AND BETA DIVERSITY FROM FIELD PLOTS ## +################################################################################ +## read selected features from dimensionality reduction + +## path for selected components + +# location of the directory where shapefiles used for validation are saved +dir.create("VectorDir") +unzip(plots_zip, exdir = "VectorDir") + +# list vector data +path_vector <- biodivMapR::list_shp("VectorDir") +name_vector <- tools::file_path_sans_ext(basename(path_vector)) + +# location of the spectral species raster needed for validation +path_spectralspecies <- kmeans_info$SpectralSpecies +# get diversity indicators corresponding to shapefiles (no partitioning of spectral dibversity based on field plots so far...) +biodiv_indicators <- biodivMapR::diversity_from_plots(Raster_SpectralSpecies = path_spectralspecies, Plots = path_vector, nbclusters = nbclusters, Raster_Functional = pca_files, Selected_Features = FALSE) + +shannon_rs <- c(biodiv_indicators$Shannon)[[1]] +fric <- c(biodiv_indicators$FunctionalDiversity$FRic) +feve <- c(biodiv_indicators$FunctionalDiversity$FEve) +fdiv <- c(biodiv_indicators$FunctionalDiversity$FDiv) +# if no name for plots +biodiv_indicators$Name_Plot <- seq(1, length(biodiv_indicators$Shannon[[1]]), by = 1) + + +#################################################### +# write RS indicators # +#################################################### +# write a table for Shannon index + +# write a table for all spectral diversity indices corresponding to alpha diversity +results <- data.frame(name_vector, biodiv_indicators$Richness, biodiv_indicators$Fisher, + biodiv_indicators$Shannon, biodiv_indicators$Simpson, + biodiv_indicators$FunctionalDiversity$FRic, + biodiv_indicators$FunctionalDiversity$FEve, + biodiv_indicators$FunctionalDiversity$FDiv) + +names(results) <- c("ID_Plot", "Species_Richness", "Fisher", "Shannon", "Simpson", "fric", "feve", "fdiv") +write.table(results, file = "Diversity.tabular", sep = "\t", dec = ".", na = " ", row.names = FALSE, col.names = TRUE, quote = FALSE) + +if (choice == "Y") { +# write a table for Bray Curtis dissimilarity +bc_mean <- biodiv_indicators$BCdiss +bray_curtis <- data.frame(name_vector, bc_mean) +colnames(bray_curtis) <- c("ID_Plot", bray_curtis[, 1]) +write.table(bray_curtis, file = "BrayCurtis.tabular", sep = "\t", dec = ".", na = " ", row.names = FALSE, col.names = TRUE, quote = FALSE) + +#################################################### +# illustrate results +#################################################### +# apply ordination using PCoA (same as done for map_beta_div) + +mat_bc_dist <- as.dist(bc_mean, diag = FALSE, upper = FALSE) +betapco <- labdsv::pco(mat_bc_dist, k = 3) + +# assign a type of vegetation to each plot, assuming that the type of vegetation +# is defined by the name of the shapefile + +nbsamples <- shpname <- c() +for (i in 1:length(path_vector)) { + shp <- path_vector[i] + nbsamples[i] <- length(rgdal::readOGR(shp, verbose = FALSE)) + shpname[i] <- tools::file_path_sans_ext(basename(shp)) +} + +type_vegetation <- c() +for (i in 1: length(nbsamples)) { + for (j in 1:nbsamples[i]) { + type_vegetation <- c(type_vegetation, shpname[i]) + } +} + +#data frame including a selection of alpha diversity metrics and beta diversity expressed as coordinates in the PCoA space +results <- data.frame("vgtype" = type_vegetation, "pco1" = betapco$points[, 1], "pco2" = betapco$points[, 2], "pco3" = betapco$points[, 3], "shannon" = shannon_rs, "fric" = fric, "feve" = feve, "fdiv" = fdiv) + +#plot field data in the PCoA space, with size corresponding to shannon index +g1 <- ggplot2::ggplot(results, ggplot2::aes(x = pco1, y = pco2, color = vgtype, size = shannon)) + ggplot2::geom_point(alpha = 0.6) + ggplot2::scale_color_manual(values = c("#e6140a", "#e6d214", "#e68214", "#145ae6")) + +g2 <- ggplot2::ggplot(results, ggplot2::aes(x = pco1, y = pco3, color = vgtype, size = shannon)) + ggplot2::geom_point(alpha = 0.6) + ggplot2::scale_color_manual(values = c("#e6140a", "#e6d214", "#e68214", "#145ae6")) + +g3 <- ggplot2::ggplot(results, ggplot2::aes(x = pco2, y = pco3, color = vgtype, size = shannon)) + ggplot2::geom_point(alpha = 0.6) + ggplot2::scale_color_manual(values = c("#e6140a", "#e6d214", "#e68214", "#145ae6")) + +#extract legend +get_legend <- function(a_gplot) { + tmp <- ggplot2::ggplot_gtable(ggplot2::ggplot_build(a_gplot)) + leg <- which(sapply(tmp$grobs, function(x) x$name) == "guide-box") + legend <- tmp$grobs[[leg]] + return(legend) +} + +legend <- get_legend(g3) +gall <- gridExtra::grid.arrange(gridExtra::arrangeGrob(g1 + ggplot2::theme(legend.position = "none"), g2 + ggplot2::theme(legend.position = "none"), g3 + ggplot2::theme(legend.position = "none"), nrow = 1), legend, nrow = 2, heights = c(3, 2)) + + +filename <- ggplot2::ggsave("BetaDiversity_PcoA1_vs_PcoA2_vs_PcoA3.png", gall, scale = 0.65, width = 12, height = 9, units = "in", dpi = 200, limitsize = TRUE) + +filename +} diff -r 000000000000 -r 33a1e15f7252 functions.r --- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/functions.r Mon Jan 09 13:37:05 2023 +0000 @@ -0,0 +1,79 @@ +#Rscript + +######################### +## Functions ## +######################### + +#####Packages : raster +# sp +# ggplot2 + +####Set paramaters for all tools using BiodivMapR + +# path for the Mask raster corresponding to image to process +# expected to be in ENVI HDR format, 1 band, integer 8bits +# expected values in the raster: 0 = masked, 1 = selected +# set to FALSE if no mask available +input_mask_file <- FALSE + +# relative or absolute path for the Directory where results will be stored +# For each image processed, a subdirectory will be created after its name +output_dir <- "RESULTS" + +# SPATIAL RESOLUTION +# resolution of spatial units for alpha and beta diversity maps (in pixels), relative to original image +# if Res.Map = 10 for images with 10 m spatial resolution, then spatial units will be 10 pixels x 10m = 100m x 100m surfaces +# rule of thumb: spatial units between 0.25 and 4 ha usually match with ground data +# too small window_size results in low number of pixels per spatial unit, hence limited range of variation of diversity in the image +window_size <- 10 + +# PCA FILTERING: Set to TRUE if you want second filtering based on PCA outliers to be processed. Slower +filterpca <- TRUE + +################################################################################ +## DEFINE PARAMETERS FOR METHOD ## +################################################################################ +nbcpu <- 4 +maxram <- 0.5 +nbclusters <- 50 + +################################################################################ +## PROCESS IMAGE ## +################################################################################ +# 1- Filter data in order to discard non vegetated / shaded / cloudy pixels +ndvi_thresh <- 0.5 +blue_thresh <- 500 +nir_thresh <- 1500 +continuum_removal <- TRUE + + + +#### Convert raster to dataframe + +# Convert raster to SpatialPointsDataFrame +convert_raster <- function(data_raster) { +r_pts <- raster::rasterToPoints(data_raster, spatial = TRUE) + +# reproject sp object +geo_prj <- "+proj=longlat +datum=WGS84 +ellps=WGS84 +towgs84=0,0,0" +r_pts <- sp::spTransform(r_pts, sp::CRS(geo_prj)) + + +# Assign coordinates to @data slot, display first 6 rows of data.frame +r_pts@data <- data.frame(r_pts@data, longitude = sp::coordinates(r_pts)[, 1], + latitude = sp::coordinates(r_pts)[, 2]) + +return(r_pts@data) +} + + +#### Potting indices + +plot_indices <- function(data, titre) { + graph_indices <- ggplot2::ggplot(data) + + ggplot2::geom_point(ggplot2::aes_string(x = data[, 2], y = data[, 3], color = data[, titre]), shape = "square", size = 2) + ggplot2::scale_colour_gradient(low = "blue", high = "orange", na.value = "grey50") + + ggplot2::xlab("Longitude") + ggplot2::ylab("Latitude") + + ggplot2::theme(axis.text.x = ggplot2::element_text(angle = 90, vjust = 0.5, hjust = 1), plot.title = ggplot2::element_text(color = "black", size = 12, face = "bold")) + ggplot2::ggtitle(titre) + +ggplot2::ggsave(paste0(titre, ".png"), graph_indices, width = 12, height = 10, units = "cm") +} diff -r 000000000000 -r 33a1e15f7252 indices_spectral.r --- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/indices_spectral.r Mon Jan 09 13:37:05 2023 +0000 @@ -0,0 +1,105 @@ +#Rscript + +########################################### +## Mapping alpha and beta diversity ## +########################################### + +#####Packages : expint, +# pracma, +# R.utils, +# raster, +# sp, +# matrixStats, +# ggplot2, +# expandFunctions, +# stringr, +# XML, +# rgdal, +# stars, +#####Load arguments + +args <- commandArgs(trailingOnly = TRUE) + +#####Import the S2 data + +if (length(args) < 1) { + stop("This tool needs at least 1 argument") +}else { + data_raster <- args[1] + data_header <- args[2] + data <- args[3] + source(args[4]) + source(args[5]) + source(args[6]) + indice_choice <- strsplit(args[7], ",")[[1]] + source(args[8]) + output_raster <- as.character(args[9]) + +} + +######################################################################## +## COMPUTE SPECTRAL INDEX : NDVI ## +######################################################################## + +if (data != "") { + #Create a directory where to unzip your folder of data + dir.create("data_dir") + unzip(data, exdir = "data_dir") + + # Read raster + data_raster <- list.files("data_dir/results/Reflectance", pattern = "_Refl") + data_raster <- file.path("data_dir/results/Reflectance", data_raster[1]) + refl <- raster::brick(data_raster) + refl2 <- raster::raster(data_raster) +} else { + # Read raster + refl <- raster::brick(data_raster) + refl2 <- raster::raster(data_raster) +} +# get raster band name and clean format. Expecting band name and wav +# reflFactor = 10000 when reflectance is coded as INT16 +refl <- raster::aggregate(refl, fact = 10) + +# Convert raster to SpatialPointsDataFrame +refl2 <- raster::aggregate(refl2, fact = 10) +r_pts <- convert_raster(refl2) +table_ind <- r_pts +# create directory for Spectralelength to be documented in image +hdr_refl <- read_envi_header(get_hdr_name(data_raster)) +sensorbands <- hdr_refl$wavelength +# compute a set of spectral indices defined by indexlist from S2 data indices +si_path <- file.path("SpectralIndices") +dir.create(path = si_path, showWarnings = FALSE, recursive = TRUE) +# Save spectral indices + +indices <- lapply(indice_choice, function(x) { + indices_list <- computespectralindices_raster(refl = refl, sensorbands = sensorbands, + sel_indices = x, + reflfactor = 10000, stackout = FALSE) + + index_path <- file.path(si_path, paste(basename(data_raster), "_", x, sep = "")) + spec_indices <- stars::write_stars(stars::st_as_stars(indices_list$spectralindices[[1]]), dsn = index_path, driver = "ENVI", type = "Float32") + + # write band name in HDR + hdr <- read_envi_header(get_hdr_name(index_path)) + hdr$`band names` <- x + write_envi_header(hdr = hdr, hdrpath = get_hdr_name(index_path)) + # Writting the tabular and the plot + r_pts[, x] <- as.data.frame(sapply(spec_indices, c)) + plot_indices(data = r_pts, titre = x) + return(r_pts) +}) + +new_table <- as.data.frame(indices) +new_table <- new_table[, !grepl("longitude", names(new_table))] +new_table <- new_table[, !grepl("latitude", names(new_table))] +new_table <- new_table[, !grepl(basename(data_raster), names(new_table))] + +table_ind <- cbind(table_ind, new_table) +if (length(indice_choice) == 1) { + colnames(table_ind) <- c(basename(data_raster), "longitude", "latitude", indice_choice) +} + +write.table(table_ind, file = "Spec_Index.tabular", sep = "\t", dec = ".", na = " ", row.names = FALSE, col.names = TRUE, quote = FALSE) + +# Get the raster layer of the indice as an output diff -r 000000000000 -r 33a1e15f7252 macro.xml --- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/macro.xml Mon Jan 09 13:37:05 2023 +0000 @@ -0,0 +1,102 @@ + + 0.0.1 + + + r-base + r-r.utils + r-sf + r-rgdal + r-rgeos + r-stars + r-stringr + r-biodivmapr + r-xfun + r-rastervis + r-ggplot2 + r-mapview + r-gridextra + r-emstreer + r-filesstrings + + + + + + + + + + + + @Manual{, + title = {obisindicators: Develop marine biodiversity indicators from OBIS data}, + author = {Ben Ben and Pieter Provoost and Tylar Murray}, + year = {2022}, + note = {https://marinebon.org/obisindicators, + https://github.com/marinebon/obisindicators}, + } + + + + + + + @Manual{, + title = {preprocS2: preprocessing of Sentinel-2 data downloaded from various data hubs / produced from various atmospheric correction methods}, + author = {Jean-Baptiste Feret}, + year = {2022}, + note = {R package version 1.1.3}, + url = {https://gitlab.com/jbferet/preprocS2}, + } + + + + + + + @Manual{, + title = {biodivMapR: biodivMapR: an R package for a- and ß-diversity mapping using remotely-sensed images}, + author = {Jean-Baptiste Feret and Florian {de Boissieu}}, + year = {2022}, + note = {R package version 1.9.4}, + url = {https://github.com/jbferet/biodivMapR}, + } + + + + + + doi:10.1016/j.ecolind.2016.07.039 + doi:10.1101/2021.01.23.427872 + + + + + + @Manual{, + title = {prosail: PROSAIL leaf and canopy radiative transfer model and inversion routines}, + author = {Jean-Baptiste Feret and Florian {de Boissieu}}, + year = {2022}, + note = {R package version 1.1.1}, + url = {https://gitlab.com/jbferet/prosail}, + } + + + + + + doi.org/10.5281/zenodo.5907920 + + + + + doi.org/10.1016/j.rse.2013.09.022 + + + + + topic_0610 + topic_3050 + + + diff -r 000000000000 -r 33a1e15f7252 pca_raster.r --- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/pca_raster.r Mon Jan 09 13:37:05 2023 +0000 @@ -0,0 +1,75 @@ +#Rscript + +########################################### +## Getting PCA raster ## +########################################### + +#####Packages : stars +# utils +# biodivmapr +# raster +# sf +# mapview +# leafpop +# RColorBrewer +# labdsv +# rgdal +# ggplot2 +# gridExtra +## remotes::install_github("jbferet/biodivMapR") +#####Load arguments + +args <- commandArgs(trailingOnly = TRUE) + +#####Import the S2 data + +if (length(args) < 1) { + stop("This tool needs at least 1 argument") +}else { + data_raster <- args[1] + rasterheader <- args[2] + data <- args[3] + typepca <- as.character(args[4]) + source(args[5]) +} + +################################################################################ +## DEFINE PARAMETERS FOR DATASET TO BE PROCESSED ## +################################################################################ +# expected to be in ENVI HDR + +if (data_raster == "") { + #Create a directory where to unzip your folder of data + dir.create("data_dir") + unzip(data, exdir = "data_dir") + # Path to raster + data_raster <- list.files("data_dir/results/Reflectance", pattern = "_Refl") + input_image_file <- file.path("data_dir/results/Reflectance", data_raster[1]) + input_header_file <- file.path("data_dir/results/Reflectance", data_raster[2]) + +} else { + input_image_file <- file.path(getwd(), data_raster, fsep = "/") + input_header_file <- file.path(getwd(), rasterheader, fsep = "/") +} + +################################################################################ +## PROCESS IMAGE ## +################################################################################ +# 1- Filter data in order to discard non vegetated / shaded / cloudy pixels +print("PERFORM PCA ON RASTER") +pca_output <- biodivMapR::perform_PCA(Input_Image_File = input_image_file, Input_Mask_File = input_mask_file, + Output_Dir = output_dir, TypePCA = typepca, FilterPCA = filterpca, nbCPU = nbcpu, MaxRAM = maxram) + + +pca_path <- file.path(output_dir, basename(data_raster), typepca, "PCA", "OutputPCA_8_PCs") +pca_raster <- raster::raster(pca_path) +get_pca <- convert_raster(pca_raster) + +colnames(get_pca) <- c("PCA", "longitude", "latitude") +plot_indices(get_pca, titre = "PCA") + +write.table(get_pca, file = "PCA.tabular", sep = "\t", dec = ".", na = " ", row.names = FALSE, col.names = TRUE, quote = FALSE) +#### Get the raster layer files +pca_files <- file.path("RESULTS", basename(data_raster), typepca, "PCA") +to_dir_short <- output_dir +file.copy(pca_files, to_dir_short) #copy files from long to short paths diff -r 000000000000 -r 33a1e15f7252 preprocess_S2.r --- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/preprocess_S2.r Mon Jan 09 13:37:05 2023 +0000 @@ -0,0 +1,121 @@ +#Rscript + +########################################### +## Preprocessing Sentinel 2 data ## +########################################### + +#####Packages : sen2r, +# jqr, +# protolite, +# raster, +# sf, +# rgeos, +# sp, +# raster, +# stars, +# stringr, +# progress, +# rgdal, +# R.utils, +# gdalUtils, +# fasterize, +# XML, +# XML2 + +#####Load arguments + +args <- commandArgs(trailingOnly = TRUE) + +if (length(args) < 1) { + stop("This tool needs at least 1 argument") +}else { + data <- args[1] + source(args[2]) + data_source <- as.character(args[3]) + sat_type <- as.character(args[4]) +} + +##____________________________________________________________________## +## Define where data is stored and where to write results ## +##--------------------------------------------------------------------## + +#Create a directory where to unzip your folder of data +dir.create("data_dir") +unzip(data, exdir = "data_dir") + +# Result directory +result_path <- "results" +dir.create(path = result_path, showWarnings = FALSE, recursive = TRUE) + +#Csv file for output useless but needed for linter +write.csv(data_source, "Mission.csv") + +# define raster path +if (data_source == "SAFE") { + path_s2 <- file.path("data_dir", list.files("data_dir", pattern = ".SAFE")) + #To define the level and know if a correction is needed (convert not ready yet) + level_info <- get_s2_level(path_s2) + if (level_info == "L1C") { + stop("! This tool works for data of L2A level and NOT for the L1C level which is currently a work in progress !") + } +}else { + path_s2 <- file.path("data_dir") +} + +##____________________________________________________________________## +## Extract, resample & stack data ## +##--------------------------------------------------------------------## +# define resolution +resolution <- 10 +# define source of data +s2source <- data_source + +s2obj <- extract_from_s2_l2a(path_dir_s2 = path_s2, + path_vector = NULL, + s2source = s2source, + resolution = resolution) + +##____________________________________________________________________## +## Write CLOUD MASK ## +##--------------------------------------------------------------------## + +# directory for cloud mask +cloud_path <- file.path(result_path, "CloudMask") +dir.create(path = cloud_path, showWarnings = FALSE, recursive = TRUE) +# Filename for cloud mask +cloudmasks <- save_cloud_s2(s2_stars = s2obj$s2_stack, + cloud_path = cloud_path, + s2source = s2source, saveraw = TRUE) + +zip_cloud <- file.path("Cloud.zip") +zip::zip(zip_cloud, cloud_path) +##____________________________________________________________________## +## Write REFLECTANCE ## +##--------------------------------------------------------------------## + +# directory for Reflectance +refl_dir <- file.path(result_path, "Reflectance") +dir.create(path = refl_dir, showWarnings = FALSE, recursive = TRUE) + +if (data_source == "SAFE") { + # filename for Reflectance + refl_path <- file.path(refl_dir, paste(basename(s2obj$s2_bands$GRANULE), "_Refl", sep = "")) + + # Save Reflectance file as ENVI image with BIL interleaves + tile_s2 <- substring(strsplit(basename(s2obj$s2_bands$GRANULE), "_")[[1]][2], 2) + dateacq_s2 <- as.Date(substring(strsplit(basename(s2obj$s2_bands$GRANULE), "_")[[1]][4], 1, 8), format = "%Y%m%d") +}else { + # filename for Reflectance + refl_path <- file.path(refl_dir, paste(basename(s2obj$s2_bands$path_tile_s2), "_Refl", sep = "")) + + # Save Reflectance file as ENVI image with BIL interleaves + tile_s2 <- substring(strsplit(basename(s2obj$s2_bands$path_tile_s2), "_")[[1]][2], 2) + dateacq_s2 <- as.Date(substring(strsplit(basename(s2obj$s2_bands$path_tile_s2), "_")[[1]][4], 1, 8), format = "%Y%m%d") +} + +save_data <- save_reflectance_s2(s2_stars = s2obj$s2_stack, refl_path = refl_path, + s2sat = sat_type, tile_s2 = tile_s2, dateacq_s2 = dateacq_s2, + format = "ENVI", datatype = "Int16", mtd = s2obj$s2_bands$metadata, mtd_msi = s2obj$s2_bands$metadata_MSI) + +zip_files <- file.path("Refl.zip") +zip::zip(zip_files, refl_dir) diff -r 000000000000 -r 33a1e15f7252 preprocess_S2.xml --- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/preprocess_S2.xml Mon Jan 09 13:37:05 2023 +0000 @@ -0,0 +1,109 @@ + + read, crop, resample and write it as a raster stack + + macro.xml + + + r-base + r-sf + r-rgeos + r-stars + r-stringr + r-jqr + r-protolite + r-sen2r + r-progress + r-gdalutils + r-fasterize + r-xml + r-xml2 + r-zip + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff -r 000000000000 -r 33a1e15f7252 prosail-master/R/Lib_PROSAIL.R --- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/prosail-master/R/Lib_PROSAIL.R Mon Jan 09 13:37:05 2023 +0000 @@ -0,0 +1,1233 @@ +# ============================================================================= = +# prosail +# Lib_PROSAIL.R +# ============================================================================= = +# PROGRAMMERS: +# Jean-Baptiste FERET +# Florian de BOISSIEU +# copyright 2019 / 11 Jean-Baptiste FERET +# ============================================================================= = +# This Library includes functions dedicated to PROSAIL simulation +# SAIL versions available are 4SAIL and 4SAIL2 +# ============================================================================= = + +#" computes bidirectional reflectance factor based on outputs from PROSAIL and sun position +#" +#" The direct and diffuse light are taken into account as proposed by: +#" Francois et al. (2002) conversion of 400-1100 nm vegetation albedo +#" measurements into total shortwave broadband albedo using a canopy +#" radiative transfer model, Agronomie +#" Es = direct +#" Ed = diffuse +#" +#" @param rdot numeric. Hemispherical-directional reflectance factor in viewing direction +#" @param rsot numeric. Bi-directional reflectance factor +#" @param tts numeric. Solar zenith angle +#" @param specatm_sensor list. direct and diffuse radiation for clear conditions +#" @return brf numeric. Bidirectional reflectance factor +#" @export +compute_brf <- function(rdot, rsot, tts, specatm_sensor) { + + ############################## # + ## direct / diffuse light ## + ############################## # + es <- specatm_sensor$Direct_Light + ed <- specatm_sensor$Diffuse_Light + rd <- pi / 180 + skyl <- 0.847 - 1.61 * sin((90 - tts) * rd) + 1.04 * sin((90 - tts) * rd) * sin((90 - tts) * rd) # diffuse radiation (Francois et al., 2002) + pardiro <- (1 - skyl) * es + pardifo <- skyl * ed + brf <- (rdot * pardifo + rsot * pardiro) / (pardiro + pardifo) + return(brf) +} + +#" Performs PROSAIL simulation based on a set of combinations of input parameters +#" @param spec_sensor list. Includes optical constants required for PROSPECT +#" refractive index, specific absorption coefficients and corresponding spectral bands +#" @param input_prospect list. PROSPECT input variables +#" @param n numeric. Leaf structure parameter +#" @param chl numeric. chlorophyll content (microg.cm-2) +#" @param car numeric. carotenoid content (microg.cm-2) +#" @param ant numeric. anthocyain content (microg.cm-2) +#" @param brown numeric. brown pigment content (Arbitrary units) +#" @param ewt numeric. Equivalent Water Thickness (g.cm-2) +#" @param lma numeric. Leaf Mass per Area (g.cm-2) +#" @param prot numeric. protein content (g.cm-2) +#" @param cbc numeric. nonprotcarbon-based constituent content (g.cm-2) +#" @param alpha numeric. Solid angle for incident light at surface of leaf (simulation of roughness) +#" @param typelidf numeric. Type of leaf inclination distribution function +#" @param lidfa numeric. +#" if typelidf == 1, controls the average leaf slope +#" if typelidf == 2, corresponds to average leaf angle +#" @param lidfb numeric. +#" if typelidf == 1, unused +#" if typelidf == 2, controls the distribution"s bimodality +#" @param lai numeric. Leaf Area Index +#" @param q numeric. Hot Spot parameter +#" @param tts numeric. Sun zeith angle +#" @param tto numeric. Observer zeith angle +#" @param psi numeric. Azimuth Sun / Observer +#" @param rsoil numeric. Soil reflectance +#" @param fraction_brown numeric. Fraction of brown leaf area +#" @param diss numeric. Layer dissociation factor +#" @param cv numeric. vertical crown cover percentage +#" = % ground area covered with crowns as seen from nadir direction +#" @param zeta numeric. Tree shape factor +#" = ratio of crown diameter to crown height +#" @param sailversion character. choose between 4SAIL and 4SAIL2 +#" @param brownvegetation list. Defines optical properties for brown vegetation, if not nULL +#" - WVL, reflectance, Transmittance +#" - Set to nULL if use PROSPECT to generate it +#" +#" @return list. rdot, rsot, rddt, rsdt +#" rdot: hemispherical-directional reflectance factor in viewing direction +#" rsot: bi-directional reflectance factor +#" rsdt: directional-hemispherical reflectance factor for solar incident flux +#" rddt: bi-hemispherical reflectance factor +#" @import prospect +#" @export +pro4sail <- function(spec_sensor, input_prospect = nULL, n = 1.5, chl = 40.0, + car = 8.0, ant = 0.0, brown = 0.0, ewt = 0.01, + lma = 0.008, prot = 0.0, cbc = 0.0, alpha = 40.0, + typelidf = 2, lidfa = nULL, lidfb = nULL, lai = nULL, + q = nULL, tts = nULL, tto = nULL, psi = nULL, rsoil = nULL, + fraction_brown = 0.0, diss = 0.0, cv = 1, zeta = 1, + sailversion = "4SAIL", brownvegetation = nULL) { + + ############################ # + # LEAF OPTICAL PROPERTIES ## + ############################ # + if (is.null(input_prospect)) { + input_prospect <- data.frame("chl" = chl, "car" = car, "ant" = ant, "brown" = brown, "ewt" = ewt, + "lma" = lma, "prot" = prot, "cbc" = cbc, "n" = n, "alpha" = alpha) + } + greenvegetation <- prospect::PROSPECT(SpecPROSPECT = spec_sensor, + n = input_prospect$n[1], + chl = input_prospect$chl[1], + car = input_prospect$car[1], + ant = input_prospect$ant[1], + brown = input_prospect$brown[1], + ewt = input_prospect$ewt[1], + lma = input_prospect$lma[1], + prot = input_prospect$prot[1], + cbc = input_prospect$cbc[1], + alpha = input_prospect$alpha[1]) + + if (sailversion == "4SAIL2") { + # 4SAIL2 requires one of the following combination of input parameters + # Case #1: valid optical properties for brown vegetation + if (!is.null(brownvegetation)) { + # need to define reflectance and Transmittance for brownvegetation + if (length(grep("reflectance", names(brownvegetation))) == 0 || length(grep("Transmittance", names(brownvegetation))) == 0) { + message("Please define brownvegetation as a list including reflectance and Transmittance") + stop() + } + # check if spectral domain for optical properties of brown vegetation match + # with spectral domain for optical properties of green vegetation + if (length(setdiff(spec_sensor$lambda, brownvegetation$wvl)) > 0) { + message("Please define same spectral domain for brownvegetation and SpecPROSPECT") + stop() + } + if (length(unique(lengths(input_prospect))) == 1) { + if (!unique(lengths(input_prospect)) == 1) { + message("brownvegetation defined along with multiple leaf chemical properties") + message("Only first set of leaf chemical properties will be used to simulate green vegetation") + } + } + # if no leaf optical properties brown vegetation defined + } else if (is.null(brownvegetation)) { + # if all PROSPECT input parameters have the same length + if (length(unique(lengths(input_prospect))) == 1) { + # if all PROSPECT input parameters are unique (no possibility to simulate 2 types of leaf optics) + if (unique(lengths(input_prospect)) == 1) { + # if fraction_brown set to 0, then assign green vegetation optics to brown vegetation optics + if (fraction_brown == 0) { + brownvegetation <- greenvegetation + # else run 4SAIL + } else { + message("4SAIL2 needs two sets of optical properties for green and brown vegetation") + message("Currently one set is defined. will run 4SAIL instead of 4SAIL2") + sailversion <- "4SAIL" + } + # if all PROSPECT parameters have at least 2 elements + } else if (unique(lengths(input_prospect)) >= 2) { + # compute leaf optical properties + brownvegetation <- prospect::PROSPECT(SpecPROSPECT = spec_sensor, + n = input_prospect$n[2], + chl = input_prospect$chl[2], + car = input_prospect$car[2], + ant = input_prospect$ant[2], + brown = input_prospect$brown[2], + ewt = input_prospect$ewt[2], + lma = input_prospect$lma[2], + prot = input_prospect$prot[2], + cbc = input_prospect$cbc[2], + alpha = input_prospect$alpha[2]) + if (unique(lengths(input_prospect)) > 2) { + message("4SAIL2 needs two sets of optical properties for green and brown vegetation") + message("Currently more than 2 sets are defined. will only use the first 2") + } + } + } + } + } + if (sailversion == "4SAIL") { + if (length(unique(lengths(input_prospect))) == 1) { + if (unique(lengths(input_prospect)) > 1) { + message("4SAIL needs only one set of optical properties") + message("Currently more than one set of leaf chemical constituents is defined.") + message("Will run 4SAIL with the first set of leaf chemical constituents") + } + } + } + + if (sailversion == "4SAIL") { + # run 4SAIL + ref <- foursail(leafoptics = greenvegetation, + typelidf, lidfa, lidfb, lai, q, tts, tto, psi, rsoil) + } else if (sailversion == "4SAIL2") { + # run 4SAIL2 + ref <- foursail2(leafgreen = greenvegetation, leafbrown = brownvegetation, + typelidf, lidfa, lidfb, lai, q, tts, tto, psi, rsoil, + fraction_brown, diss, cv, zeta) + } + return(ref) +} + +#" Performs PROSAIL simulation based on a set of combinations of input parameters +#" @param leafoptics list. Includes leaf optical properties (reflectance and transmittance) +#" and corresponding spectral bands +#" @param typelidf numeric. Type of leaf inclination distribution function +#" @param lidfa numeric. +#" if typelidf == 1, controls the average leaf slope +#" if typelidf == 2, corresponds to average leaf angle +#" @param lidfb numeric. +#" if typelidf == 1, unused +#" if typelidf == 2, controls the distribution"s bimodality +#" @param lai numeric. Leaf Area Index +#" @param q numeric. Hot Spot parameter +#" @param tts numeric. Sun zeith angle +#" @param tto numeric. Observer zeith angle +#" @param psi numeric. Azimuth Sun / Observer +#" @param rsoil numeric. Soil reflectance +#" +#" @return list. rdot, rsot, rddt, rsdt +#" rdot: hemispherical-directional reflectance factor in viewing direction +#" rsot: bi-directional reflectance factor +#" rsdt: directional-hemispherical reflectance factor for solar incident flux +#" rddt: bi-hemispherical reflectance factor +#" @export + +foursail <- function(leafoptics, typelidf = 2, lidfa = nULL, lidfb = nULL, lai = nULL, + q = nULL, tts = nULL, tto = nULL, psi = nULL, rsoil = nULL) { + + ############################## # + # LEAF OPTICAL PROPERTIES ## + ############################## # + rho <- leafoptics$Reflectance + tau <- leafoptics$Transmittance + + # Geometric quantities + rd <- pi / 180 + cts <- cos(rd * tts) + cto <- cos(rd * tto) + ctscto <- cts * cto + tants <- tan(rd * tts) + tanto <- tan(rd * tto) + cospsi <- cos(rd * psi) + dso <- sqrt(tants * tants + tanto * tanto - 2. * tants * tanto * cospsi) + + # Generate leaf angle distribution from average leaf angle (ellipsoidal) or (a, b) parameters + if (typelidf == 1) { + foliar_distrib <- dladgen(lidfa, lidfb) + lidf <- foliar_distrib$lidf + litab <- foliar_distrib$litab + + } else if (typelidf == 2) { + foliar_distrib <- campbell(lidfa) + lidf <- foliar_distrib$lidf + litab <- foliar_distrib$litab + } + + # angular distance, compensation of shadow length + # Calculate geometric factors associated with extinction and scattering + # Initialise sums + ks <- 0 + ko <- 0 + bf <- 0 + sob <- 0 + sof <- 0 + + # Weighted sums over LIDF + na <- length(litab) + for (i in 1:na) { + ttl <- litab[i] # leaf inclination discrete values + ctl <- cos(rd * ttl) + # SAIL volume scattering phase function gives interception and portions to be + # multiplied by rho and tau + resvolscatt <- volscatt(tts, tto, psi, ttl) + chi_s <- resvolscatt$chi_s + chi_o <- resvolscatt$chi_o + frho <- resvolscatt$frho + ftau <- resvolscatt$ftau + + #******************************************************************************** + #* SUITS SYSTEM coEFFICIEnTS + #* + #* ks : Extinction coefficient for direct solar flux + #* ko : Extinction coefficient for direct observed flux + #* att : Attenuation coefficient for diffuse flux + #* sigb : Backscattering coefficient of the diffuse downward flux + #* sigf : Forwardscattering coefficient of the diffuse upward flux + #* sf : Scattering coefficient of the direct solar flux for downward diffuse flux + #* sb : Scattering coefficient of the direct solar flux for upward diffuse flux + #* vf : Scattering coefficient of upward diffuse flux in the observed direction + #* vb : Scattering coefficient of downward diffuse flux in the observed direction + #* w : Bidirectional scattering coefficient + #******************************************************************************** + + # Extinction coefficients + ksli <- chi_s / cts + koli <- chi_o / cto + + # Area scattering coefficient fractions + sobli <- frho * pi / ctscto + sofli <- ftau * pi / ctscto + bfli <- ctl * ctl + ks <- ks + ksli * lidf[i] + ko <- ko + koli * lidf[i] + bf <- bf + bfli * lidf[i] + sob <- sob + sobli * lidf[i] + sof <- sof + sofli * lidf[i] + } + + # Geometric factors to be used later with rho and tau + sdb <- 0.5 * (ks + bf) + sdf <- 0.5 * (ks - bf) + dob <- 0.5 * (ko + bf) + dof <- 0.5 * (ko - bf) + ddb <- 0.5 * (1. + bf) + ddf <- 0.5 * (1. - bf) + + # Here rho and tau come in + sigb <- ddb * rho + ddf * tau + sigf <- ddf * rho + ddb * tau + att <- 1 - sigf + m2 <- (att + sigb) * (att - sigb) + m2[which(m2 <= 0)] <- 0 + m <- sqrt(m2) + + sb <- sdb * rho + sdf * tau + sf <- sdf * rho + sdb * tau + vb <- dob * rho + dof * tau + vf <- dof * rho + dob * tau + w <- sob * rho + sof * tau + + # Here the LAI comes in + # Outputs for the case LAI = 0 + if (lai < 0) { + tss <- 1 + too <- 1 + tsstoo <- 1 + rdd <- 0 + tdd <- 1 + rsd <- 0 + tsd <- 0 + rdo <- 0 + tdo <- 0 + rso <- 0 + rsos <- 0 + rsod <- 0 + + rddt <- rsoil + rsdt <- rsoil + rdot <- rsoil + rsodt <- 0 * rsoil + rsost <- rsoil + rsot <- rsoil + } else { + # Other cases (LAI > 0) + e1 <- exp(-m * lai) + e2 <- e1 * e1 + rinf <- (att - m) / sigb + rinf2 <- rinf * rinf + re <- rinf * e1 + denom <- 1. - rinf2 * e2 + + j1ks <- jfunc1(ks, m, lai) + j2ks <- jfunc2(ks, m, lai) + j1ko <- jfunc1(ko, m, lai) + j2ko <- jfunc2(ko, m, lai) + + ps <- (sf + sb * rinf) * j1ks + qs <- (sf * rinf + sb) * j2ks + pv <- (vf + vb * rinf) * j1ko + qv <- (vf * rinf + vb) * j2ko + + rdd <- rinf * (1. - e2) / denom + tdd <- (1. - rinf2) * e1 / denom + tsd <- (ps - re * qs) / denom + rsd <- (qs - re * ps) / denom + tdo <- (pv - re * qv) / denom + rdo <- (qv - re * pv) / denom + + tss <- exp(-ks * lai) + too <- exp(-ko * lai) + z <- jfunc3(ks, ko, lai) + g1 <- (z - j1ks * too) / (ko + m) + g2 <- (z - j1ko * tss) / (ks + m) + + tv1 <- (vf * rinf + vb) * g1 + tv2 <- (vf + vb * rinf) * g2 + t1 <- tv1 * (sf + sb * rinf) + t2 <- tv2 * (sf * rinf + sb) + t3 <- (rdo * qs + tdo * ps) * rinf + + # Multiple scattering contribution to bidirectional canopy reflectance + rsod <- (t1 + t2 - t3) / (1. - rinf2) + + # Treatment of the hotspot-effect + alf <- 1e6 + # Apply correction 2 / (K + k) suggested by F.-M. Breon + if (q > 0) { + alf <- (dso / q) * 2. / (ks + ko) + } + if (alf > 200) { + # inserted H. Bach 1 / 3 / 04 + alf <- 200 + } + if (alf == 0) { + # The pure hotspot - no shadow + tsstoo <- tss + sumint <- (1 - tss) / (ks * lai) + } else { + # Outside the hotspot + fhot <- lai * sqrt(ko * ks) + # Integrate by exponential Simpson method in 20 steps + # the steps are arranged according to equal partitioning + # of the slope of the joint probability function + x1 <- 0 + y1 <- 0 + f1 <- 1 + fint <- (1. - exp(-alf)) * 0.05 + sumint <- 0 + for (i in 1:20) { + if (i < 20) { + x2 <- -log(1. - i * fint) / alf + } else { + x2 <- 1 + } + y2 <- -(ko + ks) * lai * x2 + fhot * (1. - exp(-alf * x2)) / alf + f2 <- exp(y2) + sumint <- sumint + (f2 - f1) * (x2 - x1) / (y2 - y1) + x1 <- x2 + y1 <- y2 + f1 <- f2 + } + tsstoo <- f1 + } + # Bidirectional reflectance + # Single scattering contribution + rsos <- w * lai * sumint + # Total canopy contribution + rso <- rsos + rsod + # Interaction with the soil + dn <- 1. - rsoil * rdd + # rddt: bi-hemispherical reflectance factor + rddt <- rdd + tdd * rsoil * tdd / dn + # rsdt: directional-hemispherical reflectance factor for solar incident flux + rsdt <- rsd + (tsd + tss) * rsoil * tdd / dn + # rdot: hemispherical-directional reflectance factor in viewing direction + rdot <- rdo + tdd * rsoil * (tdo + too) / dn + # rsot: bi-directional reflectance factor + rsodt <- rsod + ((tss + tsd) * tdo + (tsd + tss * rsoil * rdd) * too) * rsoil / dn + rsost <- rsos + tsstoo * rsoil + rsot <- rsost + rsodt + } + my_list <- list("rdot" = rdot, "rsot" = rsot, "rddt" = rddt, "rsdt" = rsdt) + return(my_list) +} + +#" Performs pro4sail2 simulation based on a set of combinations of input parameters +#" @param leafgreen list. includes relfectance and transmittance for vegetation #1 (e.g. green vegetation) +#" @param leafbrown list. includes relfectance and transmittance for vegetation #2 (e.g. brown vegetation) +#" @param typelidf numeric. Type of leaf inclination distribution function +#" @param lidfa numeric. +#" if typelidf == 1, controls the average leaf slope +#" if typelidf == 2, corresponds to average leaf angle +#" @param lidfb numeric. +#" if typelidf == 1, unused +#" if typelidf == 2, controls the distribution"s bimodality +#" @param lai numeric. Leaf Area Index +#" @param hot numeric. Hot Spot parameter = ratio of the correlation length of leaf projections in the horizontal plane and the canopy height (doi:10.1016 / j.rse.2006.12.013) +#" @param tts numeric. Sun zeith angle +#" @param tto numeric. Observer zeith angle +#" @param psi numeric. Azimuth Sun / Observer +#" @param rsoil numeric. Soil reflectance +#" @param fraction_brown numeric. Fraction of brown leaf area +#" @param diss numeric. Layer dissociation factor +#" @param cv numeric. vertical crown cover percentage +#" = % ground area covered with crowns as seen from nadir direction +#" @param zeta numeric. Tree shape factor +#" = ratio of crown diameter to crown height +#" +#" @return list. rdot, rsot, rddt, rsdt +#" rdot: hemispherical-directional reflectance factor in viewing direction +#" rsot: bi-directional reflectance factor +#" rsdt: directional-hemispherical reflectance factor for solar incident flux +#" rddt: bi-hemispherical reflectance factor +#" alfast: canopy absorptance for direct solar incident flux +#" alfadt: canopy absorptance for hemispherical diffuse incident flux +#" @export + +foursail2 <- function(leafgreen, leafbrown, + typelidf = 2, lidfa = nULL, lidfb = nULL, + lai = nULL, hot = nULL, tts = nULL, tto = nULL, psi = nULL, rsoil = nULL, + fraction_brown = 0.5, diss = 0.5, cv = 1, zeta = 1) { + + # This version does not include non-Lambertian soil properties. + # original codes do, and only need to add the following variables as input + rddsoil <- rdosoil <- rsdsoil <- rsosoil <- rsoil + + # Geometric quantities + rd <- pi / 180 + + # Generate leaf angle distribution from average leaf angle (ellipsoidal) or (a, b) parameters + if (typelidf == 1) { + foliar_distrib <- dladgen(lidfa, lidfb) + lidf <- foliar_distrib$lidf + litab <- foliar_distrib$litab + + } else if (typelidf == 2) { + foliar_distrib <- campbell(lidfa) + lidf <- foliar_distrib$lidf + litab <- foliar_distrib$litab + } + + if (lai < 0) { + message("Please define positive LAI value") + rddt <- rsdt <- rdot <- rsost <- rsot <- rsoil + alfast <- alfadt <- 0 * rsoil + } else if (lai == 0) { + tss <- too <- tsstoo <- tdd <- 1.0 + rdd <- rsd <- tsd <- rdo <- tdo <- 0.0 + rso <- rsos <- rsod <- rsodt <- 0.0 + rddt <- rsdt <- rdot <- rsost <- rsot <- rsoil + alfast <- alfadt <- 0 * rsoil + } else if (lai > 0) { + cts <- cos(rd * tts) + cto <- cos(rd * tto) + ctscto <- cts * cto + tants <- tan(rd * tts) + tanto <- tan(rd * tto) + cospsi <- cos(rd * psi) + dso <- sqrt(tants * tants + tanto * tanto - 2.0 * tants * tanto * cospsi) + + # Clumping effects + cs <- co <- 1.0 + if (cv <= 1.0) { + cs <- 1.0 - (1.0 - cv)^(1.0 / cts) + co <- 1.0 - (1.0 - cv)^(1.0 / cto) + } + overlap <- 0.0 + if (zeta > 0.0) { + overlap <- min(cs * (1.0 - co), co * (1.0 - cs)) * exp(-dso / zeta) + } + fcd <- cs * co + overlap + fcs <- (1.0 - cs) * co - overlap + fod <- cs * (1.0 - co) - overlap + fos <- (1.0 - cs) * (1.0 - co) + overlap + fcdc <- 1.0 - (1.0 - fcd)^(0.5 / cts + 0.5 / cto) + + # Part depending on diss, fraction_brown, and leaf optical properties + # First save the input fraction_brown as the old fraction_brown, as the following change is only artificial + # Better define an fraction_brown that is actually used: fb, so that the input is not modified! + + fb <- fraction_brown + # if only green leaves + if (fraction_brown == 0.0) { + fb <- 0.5 + leafbrown$Reflectance <- leafgreen$Reflectance + leafbrown$Transmittance <- leafgreen$Transmittance + } + if (fraction_brown == 1.0) { + fb <- 0.5 + leafgreen$Reflectance <- leafbrown$Reflectance + leafgreen$Transmittance <- leafbrown$Transmittance + } + s <- (1.0 - diss) * fb * (1.0 - fb) + # rho1 && tau1 : green foliage + # rho2 && tau2 : brown foliage (bottom layer) + rho1 <- ((1 - fb - s) * leafgreen$Reflectance + s * leafbrown$Reflectance) / (1 - fb) + tau1 <- ((1 - fb - s) * leafgreen$Transmittance + s * leafbrown$Transmittance) / (1 - fb) + rho2 <- (s * leafgreen$Reflectance + (fb - s) * leafbrown$Reflectance) / fb + tau2 <- (s * leafgreen$Transmittance + (fb - s) * leafbrown$Transmittance) / fb + + # angular distance, compensation of shadow length + # Calculate geometric factors associated with extinction and scattering + # Initialise sums + ks <- ko <- bf <- sob <- sof <- 0 + + # Weighted sums over LIDF + + for (i in 1:seq_along(litab)) { + ttl <- litab[i] + ctl <- cos(rd * ttl) + # SAIL volscatt function gives interception coefficients + # and two portions of the volume scattering phase function to be + # multiplied by rho and tau, respectively + resvolscatt <- volscatt(tts, tto, psi, ttl) + chi_s <- resvolscatt$chi_s + chi_o <- resvolscatt$chi_o + frho <- resvolscatt$frho + ftau <- resvolscatt$ftau + # Extinction coefficients + ksli <- chi_s / cts + koli <- chi_o / cto + # Area scattering coefficient fractions + sobli <- frho * pi / ctscto + sofli <- ftau * pi / ctscto + bfli <- ctl * ctl + ks <- ks + ksli * lidf[i] + ko <- ko + koli * lidf[i] + bf <- bf + bfli * lidf[i] + sob <- sob + sobli * lidf[i] + sof <- sof + sofli * lidf[i] + } + # Geometric factors to be used later in combination with rho and tau + sdb <- 0.5 * (ks + bf) + sdf <- 0.5 * (ks - bf) + dob <- 0.5 * (ko + bf) + dof <- 0.5 * (ko - bf) + ddb <- 0.5 * (1. + bf) + ddf <- 0.5 * (1. - bf) + + # LAIs in two layers + lai1 <- (1 - fb) * lai + lai2 <- fb * lai + + tss <- exp(-ks * lai) + ck <- exp(-ks * lai1) + alf <- 1e6 + if (hot > 0.0) { + alf <- (dso / hot) * 2.0 / (ks + ko) + } + if (alf > 200.0) { + alf <- 200.0 # inserted H. Bach 1 / 3 / 04 + } + if (alf == 0.0) { + # The pure hotspot + tsstoo <- tss + s1 <- (1 - ck) / (ks * lai) + s2 <- (ck - tss) / (ks * lai) + } else { + # Outside the hotspot + fhot <- lai * sqrt(ko * ks) + # Integrate 2 layers by exponential simpson method in 20 steps + # the steps are arranged according to equal partitioning + # of the derivative of the joint probability function + x1 <- y1 <- 0.0 + f1 <- 1.0 + ca <- exp(alf * (fb - 1.0)) + fint <- (1.0 - ca) * .05 + s1 <- 0.0 + for (istep in 1:20) { + if (istep < 20) { + x2 <- -log(1. - istep * fint) / alf + } else { + x2 <- 1. - fb + } + y2 <- -(ko + ks) * lai * x2 + fhot * (1.0 - exp(-alf * x2)) / alf + f2 <- exp(y2) + s1 <- s1 + (f2 - f1) * (x2 - x1) / (y2 - y1) + x1 <- x2 + y1 <- y2 + f1 <- f2 + } + fint <- (ca - exp(-alf)) * .05 + s2 <- 0.0 + for (istep in 1:20) { + if (istep < 20) { + x2 <- -log(ca - istep * fint) / alf + } else { + x2 <- 1.0 + } + y2 <- -(ko + ks) * lai * x2 + fhot * (1.0 - exp(-alf * x2)) / alf + f2 <- exp(y2) + s2 <- s2 + (f2 - f1) * (x2 - x1) / (y2 - y1) + x1 <- x2 + y1 <- y2 + f1 <- f2 + } + tsstoo <- f1 + } + + # Calculate reflectances and transmittances + # Bottom layer + tss <- exp(-ks * lai2) + too <- exp(-ko * lai2) + sb <- sdb * rho2 + sdf * tau2 + sf <- sdf * rho2 + sdb * tau2 + + vb <- dob * rho2 + dof * tau2 + vf <- dof * rho2 + dob * tau2 + + w2 <- sob * rho2 + sof * tau2 + + sigb <- ddb * rho2 + ddf * tau2 + sigf <- ddf * rho2 + ddb * tau2 + att <- 1.0 - sigf + m2 <- (att + sigb) * (att - sigb) + m2[m2 < 0] <- 0 + m <- sqrt(m2) + which_ncs <- which(m > 0.01) + which_cs <- which(m <= 0.01) + + tdd <- rdd <- tsd <- rsd <- tdo <- rdo <- 0 * m + rsod <- 0 * m + if (length(which_ncs) > 0) { + resncs <- nonconservativescattering(m[which_ncs], lai2, att[which_ncs], sigb[which_ncs], + ks, ko, sf[which_ncs], sb[which_ncs], vf[which_ncs], vb[which_ncs], tss, too) + tdd[which_ncs] <- resncs$tdd + rdd[which_ncs] <- resncs$rdd + tsd[which_ncs] <- resncs$tsd + rsd[which_ncs] <- resncs$rsd + tdo[which_ncs] <- resncs$tdo + rdo[which_ncs] <- resncs$rdo + rsod[which_ncs] <- resncs$rsod + } + if (length(which_cs) > 0) { + rescs <- conservativescattering(m[which_cs], lai2, att[which_cs], sigb[which_cs], + ks, ko, sf[which_cs], sb[which_cs], vf[which_cs], vb[which_cs], tss, too) + tdd[which_cs] <- rescs$tdd + rdd[which_cs] <- rescs$rdd + tsd[which_cs] <- rescs$tsd + rsd[which_cs] <- rescs$rsd + tdo[which_cs] <- rescs$tdo + rdo[which_cs] <- rescs$rdo + rsod[which_cs] <- rescs$rsod + } + + # Set background properties equal to those of the bottom layer on a black soil + rddb <- rdd + rsdb <- rsd + rdob <- rdo + rsodb <- rsod + tddb <- tdd + tsdb <- tsd + tdob <- tdo + toob <- too + tssb <- tss + # Top layer + tss <- exp(-ks * lai1) + too <- exp(-ko * lai1) + + sb <- sdb * rho1 + sdf * tau1 + sf <- sdf * rho1 + sdb * tau1 + + vb <- dob * rho1 + dof * tau1 + vf <- dof * rho1 + dob * tau1 + + w1 <- sob * rho1 + sof * tau1 + + sigb <- ddb * rho1 + ddf * tau1 + sigf <- ddf * rho1 + ddb * tau1 + att <- 1.0 - sigf + + m2 <- (att + sigb) * (att - sigb) + m2[m2 < 0] <- 0 + m <- sqrt(m2) + which_ncs <- which(m > 0.01) + which_cs <- which(m <= 0.01) + + tdd <- rdd <- tsd <- rsd <- tdo <- rdo <- 0 * m + rsod <- 0 * m + if (length(which_ncs) > 0) { + resncs <- nonconservativescattering(m[which_ncs], lai1, att[which_ncs], sigb[which_ncs], + ks, ko, sf[which_ncs], sb[which_ncs], vf[which_ncs], vb[which_ncs], tss, too) + tdd[which_ncs] <- resncs$tdd + rdd[which_ncs] <- resncs$rdd + tsd[which_ncs] <- resncs$tsd + rsd[which_ncs] <- resncs$rsd + tdo[which_ncs] <- resncs$tdo + rdo[which_ncs] <- resncs$rdo + rsod[which_ncs] <- resncs$rsod + } + if (length(which_cs) > 0) { + rescs <- conservativescattering(m[which_cs], lai1, att[which_cs], sigb[which_cs], + ks, ko, sf[which_cs], sb[which_cs], vf[which_cs], vb[which_cs], tss, too) + tdd[which_cs] <- rescs$tdd + rdd[which_cs] <- rescs$rdd + tsd[which_cs] <- rescs$tsd + rsd[which_cs] <- rescs$rsd + tdo[which_cs] <- rescs$tdo + rdo[which_cs] <- rescs$rdo + rsod[which_cs] <- rescs$rsod + } + + # combine with bottom layer reflectances and transmittances (adding method) + rn <- 1.0 - rdd * rddb + tup <- (tss * rsdb + tsd * rddb) / rn + tdn <- (tsd + tss * rsdb * rdd) / rn + rsdt <- rsd + tup * tdd + rdot <- rdo + tdd * (rddb * tdo + rdob * too) / rn + rsodt <- rsod + (tss * rsodb + tdn * rdob) * too + tup * tdo + + rsost <- (w1 * s1 + w2 * s2) * lai + + rsot <- rsost + rsodt + + # Diffuse reflectances at the top and the bottom are now different + rddt_t <- rdd + tdd * rddb * tdd / rn + rddt_b <- rddb + tddb * rdd * tddb / rn + + # Transmittances of the combined canopy layers + tsst <- tss * tssb + toot <- too * toob + tsdt <- tss * tsdb + tdn * tddb + tdot <- tdob * too + tddb * (tdo + rdd * rdob * too) / rn + tddt <- tdd * tddb / rn + + # Apply clumping effects to vegetation layer + rddcb <- cv * rddt_b + rddct <- cv * rddt_t + tddc <- 1 - cv + cv * tddt + rsdc <- cs * rsdt + tsdc <- cs * tsdt + rdoc <- co * rdot + tdoc <- co * tdot + tssc <- 1 - cs + cs * tsst + tooc <- 1 - co + co * toot + + # new weight function fcdc for crown contribution (W. Verhoef, 22-05-08) + rsoc <- fcdc * rsot + tssooc <- fcd * tsstoo + fcs * toot + fod * tsst + fos + # Canopy absorptance for black background (W. Verhoef, 02-03-04) + alfas <- 1. - tssc - tsdc - rsdc + alfad <- 1. - tddc - rddct + # Add the soil background + rn <- 1 - rddcb * rddsoil + tup <- (tssc * rsdsoil + tsdc * rddsoil) / rn + tdn <- (tsdc + tssc * rsdsoil * rddcb) / rn + + rddt <- rddct + tddc * rddsoil * tddc / rn + rsdt <- rsdc + tup * tddc + rdot <- rdoc + tddc * (rddsoil * tdoc + rdosoil * tooc) / rn + rsot <- rsoc + tssooc * rsosoil + tdn * rdosoil * tooc + tup * tdoc + + # Effect of soil background on canopy absorptances (W. Verhoef, 02-03-04) + alfast <- alfas + tup * alfad + alfadt <- alfad * (1. + tddc * rddsoil / rn) + } + my_list <- list("rdot" = rdot, "rsot" = rsot, "rddt" = rddt, "rsdt" = rsdt, + "alfast" = alfast, "alfadt" = alfadt) + return(my_list) +} + + + +#" computes non conservative scattering conditions +#" @param m numeric. +#" @param lai numeric. Leaf Area Index +#" @param att numeric. +#" @param sigb numeric. +#" @param ks numeric. +#" @param ko numeric. +#" @param sf numeric. +#" @param sb numeric. +#" @param vf numeric. +#" @param vb numeric. +#" @param tss numeric. +#" @param too numeric. +#" +#" @return list. tdd, rdd, tsd, rsd, tdo, rdo, rsod +#" +#" @export +nonconservativescattering <- function(m, lai, att, sigb, ks, ko, sf, sb, vf, vb, tss, too) { + + e1 <- exp(-m * lai) + e2 <- e1 * e1 + rinf <- (att - m) / sigb + rinf2 <- rinf * rinf + re <- rinf * e1 + denom <- 1. - rinf2 * e2 + + j1ks <- jfunc1(ks, m, lai) + j2ks <- jfunc2(ks, m, lai) + j1ko <- jfunc1(ko, m, lai) + j2ko <- jfunc2(ko, m, lai) + + ps <- (sf + sb * rinf) * j1ks + qs <- (sf * rinf + sb) * j2ks + pv <- (vf + vb * rinf) * j1ko + qv <- (vf * rinf + vb) * j2ko + + tdd <- (1. - rinf2) * e1 / denom + rdd <- rinf * (1. - e2) / denom + tsd <- (ps - re * qs) / denom + rsd <- (qs - re * ps) / denom + tdo <- (pv - re * qv) / denom + rdo <- (qv - re * pv) / denom + + z <- jfunc2(ks, ko, lai) + g1 <- (z - j1ks * too) / (ko + m) + g2 <- (z - j1ko * tss) / (ks + m) + + tv1 <- (vf * rinf + vb) * g1 + tv2 <- (vf + vb * rinf) * g2 + + t1 <- tv1 * (sf + sb * rinf) + t2 <- tv2 * (sf * rinf + sb) + t3 <- (rdo * qs + tdo * ps) * rinf + + # Multiple scattering contribution to bidirectional canopy reflectance + rsod <- (t1 + t2 - t3) / (1. - rinf2) + my_list <- list("tdd" = tdd, "rdd" = rdd, "tsd" = tsd, + "rsd" = rsd, "tdo" = tdo, "rdo" = rdo, + "rsod" = rsod) + return(my_list) +} + +#" computes conservative scattering conditions +#" @param m numeric. +#" @param lai numeric. Leaf Area Index +#" @param att numeric. +#" @param sigb numeric. +#" @param ks numeric. +#" @param ko numeric. +#" @param sf numeric. +#" @param sb numeric. +#" @param vf numeric. +#" @param vb numeric. +#" @param tss numeric. +#" @param too numeric. +#" +#" @return list. tdd, rdd, tsd, rsd, tdo, rdo, rsod +#" +#" @export +conservativescattering <- function(m, lai, att, sigb, ks, ko, sf, sb, vf, vb, tss, too) { + + # near or complete conservative scattering + j4 <- jfunc4(m, lai) + amsig <- att - sigb + apsig <- att + sigb + rtp <- (1 - amsig * j4) / (1 + amsig * j4) + rtm <- (-1 + apsig * j4) / (1 + apsig * j4) + rdd <- 0.5 * (rtp + rtm) + tdd <- 0.5 * (rtp - rtm) + + dns <- ks * ks - m * m + dno <- ko * ko - m * m + cks <- (sb * (ks - att) - sf * sigb) / dns + cko <- (vb * (ko - att) - vf * sigb) / dno + dks <- (-sf * (ks + att) - sb * sigb) / dns + dko <- (-vf * (ko + att) - vb * sigb) / dno + ho <- (sf * cko + sb * dko) / (ko + ks) + + rsd <- cks * (1 - tss * tdd) - dks * rdd + rdo <- cko * (1 - too * tdd) - dko * rdd + tsd <- dks * (tss - tdd) - cks * tss * rdd + tdo <- dko * (too - tdd) - cko * too * rdd + # Multiple scattering contribution to bidirectional canopy reflectance + rsod <- ho * (1 - tss * too) - cko * tsd * too - dko * rsd + + my_list <- list("tdd" = tdd, "rdd" = rdd, "tsd" = tsd, + "rsd" = rsd, "tdo" = tdo, "rdo" = rdo, + "rsod" = rsod) + return(my_list) +} + + + + + + +#" computes the leaf angle distribution function value (freq) +#" +#" Ellipsoidal distribution function characterised by the average leaf +#" inclination angle in degree (ala) +#" Campbell 1986 +#" @param ala average leaf angle +#" @return foliar_distrib list. lidf and litab +#" @export +campbell <- function(ala) { + + tx1 <- c(10., 20., 30., 40., 50., 60., 70., 80., 82., 84., 86., 88., 90.) + tx2 <- c(0., 10., 20., 30., 40., 50., 60., 70., 80., 82., 84., 86., 88.) + litab <- (tx2 + tx1) / 2 + n <- length(litab) + tl1 <- tx1 * (pi / 180) + tl2 <- tx2 * (pi / 180) + excent <- exp(-1.6184e-5 * ala**3 + 2.1145e-3 * ala**2 - 1.2390e-1 * ala + 3.2491) + sum0 <- 0 + + freq <- c() + for (i in 1:n) { + x1 <- excent / (sqrt(1. + excent**2. * tan(tl1[i])**2)) + x2 <- excent / (sqrt(1. + excent**2. * tan(tl2[i])**2)) + if (excent == 1) { + freq[i] <- abs(cos(tl1[i]) - cos(tl2[i])) + } else { + alpha <- excent / sqrt(abs(1 - excent**2)) + alpha2 <- alpha**2 + x12 <- x1**2 + x22 <- x2**2 + alpx1 <- 0 * alpha2 + alpx2 <- 0 * alpha2 + almx1 <- 0 * alpha2 + almx2 <- 0 * alpha2 + if (excent > 1) { + alpx1 <- sqrt(alpha2[excent > 1] + x12[excent > 1]) + alpx2[excent > 1] <- sqrt(alpha2[excent > 1] + x22[excent > 1]) + dum <- x1 * alpx1 + alpha2 * log(x1 + alpx1) + freq[i] <- abs(dum - (x2 * alpx2 + alpha2 * log(x2 + alpx2))) + } else { + almx1 <- sqrt(alpha2 - x12) + almx2 <- sqrt(alpha2 - x22) + dum <- x1 * almx1 + alpha2 * asin(x1 / alpha) + freq[i] <- abs(dum - (x2 * almx2 + alpha2 * asin(x2 / alpha))) + } + } + } + sum0 <- sum(freq) + freq0 <- freq / sum0 + foliar_distrib <- list("lidf" = freq0, "litab" = litab) + return(foliar_distrib) +} + +#" computes the leaf angle distribution function value (freq) +#" +#" Using the original bimodal distribution function initially proposed in SAIL +#" references +#" ---------- +#" (Verhoef1998) Verhoef, Wout. Theory of radiative transfer models applied +#" in optical remote sensing of vegetation canopies. +#" nationaal Lucht en Ruimtevaartlaboratorium, 1998. +#" http: / / library.wur.nl / WebQuery / clc / 945481. +#" @param a controls the average leaf slope +#" @param b controls the distribution"s bimodality +#" LIDF type a b +#" Planophile 1 0 +#" Erectophile -1 0 +#" Plagiophile 0 -1 +#" Extremophile 0 1 +#" Spherical -0.35 -0.15 +#" Uniform 0 0 +#" requirement: ||lidfa|| + ||lidfb|| < 1 +#" +#" @return foliar_distrib list. lidf and litab +#" @export +dladgen <- function(a, b) { + litab <- c(5., 15., 25., 35., 45., 55., 65., 75., 81., 83., 85., 87., 89.) + freq <- c() + for (i1 in 1:8) { + t <- i1 * 10 + freq[i1] <- dcum(a, b, t) + } + for (i2 in 9:12) { + t <- 80. + (i2 - 8) * 2. + freq[i2] <- dcum(a, b, t) + } + freq[13] <- 1 + for (i in 13:2) { + freq[i] <- freq[i] - freq[i - 1] + } + foliar_distrib <- list("lidf" = freq, "litab" = litab) + return(foliar_distrib) +} + +#" dcum function +#" @param a numeric. controls the average leaf slope +#" @param b numeric. controls the distribution"s bimodality +#" @param t numeric. angle +#" @return f +#" @export +dcum <- function(a, b, t) { + rd <- pi / 180 + if (a >= 1) { + f <- 1 - cos(rd * t) + } else { + eps <- 1e-8 + delx <- 1 + x <- 2 * rd * t + p <- x + while (delx >= eps) { + y <- a * sin(x) + .5 * b * sin(2. * x) + dx <- .5 * (y - x + p) + x <- x + dx + delx <- abs(dx) + } + f <- (2. * y + p) / pi + } + return(f) +} + +#" J1 function with avoidance of singularity problem +#" +#" @param k numeric. Extinction coefficient for direct (solar or observer) flux +#" @param l numeric. +#" @param t numeric. Leaf Area Index +#" @return jout numeric. +#" @export +jfunc1 <- function(k, l, t) { + # J1 function with avoidance of singularity problem + del <- (k - l) * t + jout <- 0 * l + jout[which(abs(del) > 1e-3)] <- (exp(-l[which(abs(del) > 1e-3)] * t) - exp(-k * t)) / (k - l[which(abs(del) > 1e-3)]) + jout[which(abs(del) <= 1e-3)] <- 0.5 * t * (exp(-k * t) + exp(-l[which(abs(del) <= 1e-3)] * t)) * (1 - del[which(abs(del) <= 1e-3)] * del[which(abs(del) <= 1e-3)] / 12) + return(jout) +} + +#" J2 function with avoidance of singularity problem +#" +#" @param k numeric. Extinction coefficient for direct (solar or observer) flux +#" @param l numeric. +#" @param t numeric. Leaf Area Index +#" @return jout numeric. +#" @export +jfunc2 <- function(k, l, t) { + # J2 function + jout <- (1. - exp(-(k + l) * t)) / (k + l) + return(jout) +} + +#" J3 function with avoidance of singularity problem +#" +#" @param k numeric. Extinction coefficient for direct (solar or observer) flux +#" @param l numeric. +#" @param t numeric. Leaf Area Index +#" @return jout numeric. +#" @export +jfunc3 <- function(k, l, t) { + out <- (1. - exp(-(k + l) * t)) / (k + l) + return(out) +} + + +#" j4 function for treating (near) conservative scattering +#" +#" @param m numeric. Extinction coefficient for direct (solar or observer) flux +#" @param t numeric. Leaf Area Index +#" @return jout numeric. +#" @export +jfunc4 <- function(m, t) { + + del <- m * t + out <- 0 * del + out[del > 1e-3] <- (1 - exp(-del)) / (m * (1 + exp(-del))) + out[del <= 1e-3] <- 0.5 * t * (1. - del * del / 12.) + return(out) +} + + +#" compute volume scattering functions and interception coefficients +#" for given solar zenith, viewing zenith, azimuth and leaf inclination angle. +#" +#" @param tts numeric. solar zenith +#" @param tto numeric. viewing zenith +#" @param psi numeric. azimuth +#" @param ttl numeric. leaf inclination angle +#" @return res list. includes chi_s, chi_o, frho, ftau +#" @export +volscatt <- function(tts, tto, psi, ttl) { + #******************************************************************************** + #* chi_s = interception functions + #* chi_o = interception functions + #* frho = function to be multiplied by leaf reflectance rho + #* ftau = functions to be multiplied by leaf transmittance tau + #******************************************************************************** + # Wout Verhoef, april 2001, for CROMA + + rd <- pi / 180 + costs <- cos(rd * tts) + costo <- cos(rd * tto) + sints <- sin(rd * tts) + sinto <- sin(rd * tto) + cospsi <- cos(rd * psi) + psir <- rd * psi + costl <- cos(rd * ttl) + sintl <- sin(rd * ttl) + cs <- costl * costs + co <- costl * costo + ss <- sintl * sints + so <- sintl * sinto + + #c .............................................................................. + #c betas -bts- and betao -bto- computation + #c Transition angles (beta) for solar (betas) and view (betao) directions + #c if thetav + thetal > pi / 2, bottom side of the leaves is observed for leaf azimut + #c interval betao + phi 1e-6) { + cosbts <- -cs / ss + } + cosbto <- 5 + if (abs(so) > 1e-6) { + cosbto <- -co / so + } + + if (abs(cosbts) < 1) { + bts <- acos(cosbts) + ds <- ss + } else { + bts <- pi + ds <- cs + } + chi_s <- 2. / pi * ((bts - pi * .5) * cs + sin(bts) * ss) + if (abs(cosbto) < 1) { + bto <- acos(cosbto) + doo <- so + } else if (tto < 90) { + bto <- pi + doo <- co + } else { + bto <- 0 + doo <- -co + } + chi_o <- 2. / pi * ((bto - pi * .5) * co + sin(bto) * so) + + #c .............................................................................. + #c computation of auxiliary azimut angles bt1, bt2, bt3 used + #c for the computation of the bidirectional scattering coefficient w + #c ............................................................................. + + btran1 <- abs(bts - bto) + btran2 <- pi - abs(bts + bto - pi) + + if (psir <= btran1) { + bt1 <- psir + bt2 <- btran1 + bt3 <- btran2 + } else { + bt1 <- btran1 + if (psir <= btran2) { + bt2 <- psir + bt3 <- btran2 + } else { + bt2 <- btran2 + bt3 <- psir + } + } + t1 <- 2. * cs * co + ss * so * cospsi + t2 <- 0 + if (bt2 > 0) { + t2 <- sin(bt2) * (2. * ds * doo + ss * so * cos(bt1) * cos(bt3)) + } + + denom <- 2. * pi * pi + frho <- ((pi - bt2) * t1 + t2) / denom + ftau <- (-bt2 * t1 + t2) / denom + + if (frho < 0) { + frho <- 0 + } + if (ftau < 0) { + ftau <- 0 + } + res <- list("chi_s" = chi_s, "chi_o" = chi_o, "frho" = frho, "ftau" = ftau) + return(res) +} diff -r 000000000000 -r 33a1e15f7252 prosail-master/R/Lib_PROSAIL_HybridInversion.R --- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/prosail-master/R/Lib_PROSAIL_HybridInversion.R Mon Jan 09 13:37:05 2023 +0000 @@ -0,0 +1,554 @@ +# ============================================================================= = +# prosail +# Lib_PROSAIL_HybridInversion.R +# ============================================================================= = +# PROGRAMMERS: +# Jean-Baptiste FERET +# Florian de BOISSIEU +# Copyright 2019 / 11 Jean-Baptiste FERET +# ============================================================================= = +# This Library includes functions dedicated to PROSAIL inversion using hybrid +# approach based on SVM regression +# ============================================================================= = + + +#" This function applies SVR model on raster data in order to estimate +#" vegetation biophysical properties +#" +#" @param raster_path character. path for a raster file +#" @param hybridmodel list. hybrid models produced from train_prosail_inversion +#" each element of the list corresponds to a set of hybrid models for a vegetation parameter +#" @param pathout character. path for directory where results are written +#" @param selectedbands list. list of spectral bands to be selected from raster (identified by name of vegetation parameter) +#" @param bandname character. spectral bands corresponding to the raster +#" @param maskraster character. path for binary mask defining ON (1) and OFF (0) pixels in the raster +#" @param multiplyingfactor numeric. multiplying factor used to write reflectance in the raster +#" --> PROSAIL simulates reflectance between 0 and 1, and raster data expected in the same range +#" +#" @return None +#" @importFrom progress progress_bar +#" @importFrom stars read_stars +#" @importFrom raster raster brick blockSize readStart readStop getValues writeStart writeStop writeValues +#" @import rgdal +#" @export +apply_prosail_inversion <- function(raster_path, hybridmodel, pathout, + selectedbands, bandname, + maskraster = FALSE, multiplyingfactor = 10000) { + + # explain which biophysical variables will be computed + bpvar <- names(hybridmodel) + print("The following biophysical variables will be computed") + print(bpvar) + + # get image dimensions + if (attr(rgdal::GDALinfo(raster_path, returnStats = FALSE), "driver") == "ENVI") { + hdr <- read_envi_header(get_hdr_name(raster_path)) + dimsraster <- list("rows" = hdr$lines, "cols" = hdr$samples, "bands" = hdr$bands) + } else { + dimsraster <- dim(read_stars(raster_path)) + dimsraster <- list("rows" = as.numeric(dimsraster[2]), "cols" = as.numeric(dimsraster[1]), "bands" = as.numeric(dimsraster[3])) + } + + # Produce a map for each biophysical property + for (parm in bpvar) { + print(paste("Computing", parm, sep = " ")) + # read by chunk to avoid memory problem + blk <- blockSize(brick(raster_path)) + # reflectance file + r_in <- readStart(brick(raster_path)) + # mask file + r_inmask <- FALSE + if (maskraster == FALSE) { + selectpixels <- "ALL" + } else if (!maskraster == FALSE) { + if (file.exists(maskraster)) { + r_inmask <- readStart(raster(maskraster)) + } else if (!file.exists(maskraster)) { + message("WARNING: Mask file does not exist:") + print(maskraster) + message("Processing all image") + selectpixels <- "ALL" + } + } + # initiate progress bar + pgbarlength <- length(hybridmodel[[parm]]) * blk$n + pb <- progress_bar$new( + format = "Hybrid inversion on raster [:bar] :percent in :elapsedfull, estimated time remaining :eta", + total = pgbarlength, clear = FALSE, width = 100) + + # output files + bpvarpath <- file.path(pathout, paste(basename(raster_path), parm, sep = "_")) + bpvarsdpath <- file.path(pathout, paste(basename(raster_path), parm, "STD", sep = "_")) + r_outmean <- writeStart(raster(raster_path), filename = bpvarpath, format = "ENVI", overwrite = TRUE) + r_outsd <- writeStart(raster(raster_path), filename = bpvarsdpath, format = "ENVI", overwrite = TRUE) + selbands <- match(selectedbands[[parm]], bandname) + + # loop over blocks + for (i in seq_along(blk$row)) { + # read values for block + # format is a matrix with rows the cells values and columns the layers + blockval <- getValues(r_in, row = blk$row[i], nrows = blk$nrows[i]) + fulllength <- dim(blockval)[1] + + if (typeof(r_inmask) == "logical") { + blockval <- blockval[, selbands] + # automatically filter pixels corresponding to negative values + selectpixels <- which(blockval[, 1] > 0) + blockval <- blockval[selectpixels, ] + } else if (typeof(r_inmask) == "S4") { + maskval <- getValues(r_inmask, row = blk$row[i], nrows = blk$nrows[i]) + selectpixels <- which(maskval == 1) + blockval <- blockval[selectpixels, selbands] + } + mean_estimatefull <- NA * vector(length = fulllength) + std_estimatefull <- NA * vector(length = fulllength) + if (length(selectpixels) > 0) { + blockval <- blockval / multiplyingfactor + modelsvr_estimate <- list() + for (modind in 1:seq_along(hybridmodel[[parm]])) { + pb$tick() + modelsvr_estimate[[modind]] <- predict(hybridmodel[[parm]][[modind]], blockval) + } + modelsvr_estimate <- do.call(cbind, modelsvr_estimate) + # final estimated value = mean parm value for all models + mean_estimate <- rowMeans(modelsvr_estimate) + # "uncertainty" = STD value for all models + std_estimate <- rowSds(modelsvr_estimate) + mean_estimatefull[selectpixels] <- mean_estimate + std_estimatefull[selectpixels] <- std_estimate + } else { + for (modind in 1:seq_along(hybridmodel[[parm]])) { + pb$tick() + } + } + r_outmean <- writeValues(r_outmean, mean_estimatefull, blk$row[i], format = "ENVI", overwrite = TRUE) + r_outsd <- writeValues(r_outsd, std_estimatefull, blk$row[i], format = "ENVI", overwrite = TRUE) + } + # close files + r_in <- readStop(r_in) + if (typeof(r_inmask) == "S4") { + r_inmask <- readStop(r_inmask) + } + r_outmean <- writeStop(r_outmean) + r_outsd <- writeStop(r_outsd) + # write biophysical variable name in headers + hdr <- read_envi_header(get_hdr_name(bpvarpath)) + hdr$`band names` <- paste("{", parm, "}", sep = "") + write_envi_header(hdr, get_hdr_name(bpvarpath)) + } + print("processing completed") + return(invisible()) +} + +#" get hdr name from image file name, assuming it is BIL format +#" +#" @param impath path of the image +#" +#" @return corresponding hdr +#" @importFrom tools file_ext file_path_sans_ext +#" @export +get_hdr_name <- function(impath) { + if (tools::file_ext(impath) == "") { + impathhdr <- paste(impath, ".hdr", sep = "") + } else if (tools::file_ext(impath) == "bil") { + impathhdr <- gsub(".bil", ".hdr", impath) + } else if (tools::file_ext(impath) == "zip") { + impathhdr <- gsub(".zip", ".hdr", impath) + } else { + impathhdr <- paste(tools::file_path_sans_ext(impath), ".hdr", sep = "") + } + + if (!file.exists(impathhdr)) { + message("WARNING : COULD NOT FIND hdr FILE") + print(impathhdr) + message("Process may stop") + } + return(impathhdr) +} + +#" This function applies the regression models trained with prosail_hybrid_train +#" +#" @param regressionmodels list. List of regression models produced by prosail_hybrid_train +#" @param refl numeric. LUT of bidirectional reflectances factors used for training +#" +#" @return hybridres list. Estimated values corresponding to refl. Includes +#" - meanestimate = mean value for the ensemble regression model +#" - stdestimate = std value for the ensemble regression model +#" @importFrom stats predict +#" @importFrom matrixStats rowSds +#" @importFrom progress progress_bar +#" @export + +prosail_hybrid_apply <- function(regressionmodels, refl) { + + # make sure refl is right dimensions + refl <- t(refl) + nbfeatures <- regressionmodels[[1]]$dim + if (!ncol(refl) == nbfeatures && nrow(refl) == nbfeatures) { + refl <- t(refl) + } + nbensemble <- length(regressionmodels) + estimatedval <- list() + pb <- progress_bar$new( + format = "Applying SVR models [:bar] :percent in :elapsed", + total = nbensemble, clear = FALSE, width = 100) + for (i in 1:nbensemble) { + pb$tick() + estimatedval[[i]] <- predict(regressionmodels[[i]], refl) + } + estimatedval <- do.call(cbind, estimatedval) + meanestimate <- rowMeans(estimatedval) + stdestimate <- rowSds(estimatedval) + hybridres <- list("meanestimate" = meanestimate, "stdestimate" = stdestimate) + return(hybridres) +} + +#" This function trains a suppot vector regression for a set of variables based on spectral data +#" +#" @param brf_lut numeric. LUT of bidirectional reflectances factors used for training +#" @param inputvar numeric. biophysical parameter corresponding to the reflectance +#" @param figplot Boolean. Set to TRUE if you want a scatterplot +#" @param nbensemble numeric. Number of individual subsets should be generated from brf_lut +#" @param withreplacement Boolean. should subsets be generated with or without replacement? +#" +#" @return modelssvr list. regression models trained for the retrieval of inputvar based on brf_lut +#" @importFrom liquidSVM svmRegression +#" @importFrom stats predict +#" @importFrom progress progress_bar +#" @importFrom graphics par +#" @importFrom expandFunctions reset.warnings +#" @importFrom stringr str_split +#" @importFrom simsalapar tryCatch.W.E +#" @import dplyr +#" @import ggplot2 +# @" @import caret +#" @export + +prosail_hybrid_train <- function(brf_lut, inputvar, figplot = FALSE, nbensemble = 20, withreplacement = FALSE) { + + x <- y <- ymean <- ystdmin <- ystdmax <- NULL + # split the LUT into nbensemble subsets + nbsamples <- length(inputvar) + if (dim(brf_lut)[2] == nbsamples) { + brf_lut <- t(brf_lut) + } + + # if subsets are generated from brf_lut with replacement + if (withreplacement == TRUE) { + subsets <- list() + samples_per_run <- round(nbsamples / nbensemble) + for (run in (1:nbensemble)) { + subsets[[run]] <- sample(seq(1, nbsamples), samples_per_run, replace = TRUE) + } + # if subsets are generated from brf_lut without replacement + } else if (withreplacement == FALSE) { + subsets <- split(sample(seq(1, nbsamples, by = 1)), seq(1, nbensemble, by = 1)) + } + + # run training for each subset + modelssvr <- list() + predictedyall <- list() + tunedmodelyall <- list() + pb <- progress_bar$new( + format = "Training SVR on subsets [:bar] :percent in :elapsed", + total = nbensemble, clear = FALSE, width = 100) + for (i in 1:nbensemble) { + pb$tick() + Sys.sleep(1 / 100) + trainingset <- list() + trainingset$X <- brf_lut[subsets[i][[1]], ] + trainingset$Y <- inputvar[subsets[i][[1]]] + # liquidSVM + r1 <- tryCatch.W.E(tunedmodel <- liquidSVM::svmRegression(trainingset$X, trainingset$Y)) + if (!is.null(r1$warning)) { + msg <- r1$warning$message + valgamma <- str_split(string = msg, pattern = "gamma=")[[1]][2] + vallambda <- str_split(string = msg, pattern = "lambda=")[[1]][2] + if (!is.na(as.numeric(valgamma))) { + message("Adjusting Gamma accordingly") + valgamma <- as.numeric(valgamma) + tunedmodel <- liquidSVM::svmRegression(trainingset$X, trainingset$Y, min_gamma = valgamma) + } + if (!is.na(as.numeric(vallambda))) { + message("Adjusting Lambda accordingly") + vallambda <- as.numeric(vallambda) + tunedmodel <- liquidSVM::svmRegression(trainingset$X, trainingset$Y, min_lambda = vallambda) + } + } + modelssvr[[i]] <- tunedmodel + } + + # if scatterplots needed + if (figplot == TRUE) { + # predict for full brf_lut + for (i in 1:nbensemble) { + tunedmodely <- stats::predict(modelssvr[[i]], brf_lut) + tunedmodelyall <- cbind(tunedmodelyall, matrix(tunedmodely, ncol = 1)) + } + # plot prediction + df <- data.frame(x = rep(1:nbsamples, nbensemble), y = as.numeric(matrix(tunedmodelyall, ncol = 1))) + df_summary <- df %>% + dplyr::group_by(x) %>% + summarize(ymin = min(y), ystdmin = mean(y) - sd(y), + ymax = max(y), ystdmax = mean(y) + sd(y), + ymean = mean(y)) + par(mar = rep(.1, 4)) + p <- ggplot(df_summary, aes(x = inputvar, y = ymean)) + + geom_point(size = 2) + + geom_errorbar(aes(ymin = ystdmin, ymax = ystdmax)) + meanpredict <- rowMeans(matrix(as.numeric(tunedmodelyall), ncol = nbensemble)) + print(p) + } + return(modelssvr) +} + +#" Reads ENVI hdr file +#" +#" @param hdrpath Path of the hdr file +#" +#" @return list of the content of the hdr file +#" @export +read_envi_header <- function(hdrpath) { + if (!grepl(".hdr$", hdrpath)) { + stop("File extension should be .hdr") + } + hdr <- readLines(hdrpath) + ## check ENVI at beginning of file + if (!grepl("ENVI", hdr[1])) { + stop("Not an ENVI header (ENVI keyword missing)") + } else { + hdr <- hdr [-1] + } + ## remove curly braces and put multi-line key-value-pairs into one line + hdr <- gsub("\\{([^}]*)\\}", "\\1", hdr) + l <- grep("\\{", hdr) + r <- grep("\\}", hdr) + + if (length(l) != length(r)) { + stop("Error matching curly braces in header (differing numbers).") + } + + if (any(r <= l)) { + stop("Mismatch of curly braces in header.") + } + + hdr[l] <- sub("\\{", "", hdr[l]) + hdr[r] <- sub("\\}", "", hdr[r]) + + for (i in rev(seq_along(l))) { + hdr <- c( + hdr [seq_len(l [i] - 1)], + paste(hdr [l [i]:r [i]], collapse = "\n"), + hdr [-seq_len(r [i])] + ) + } + + ## split key = value constructs into list with keys as names + hdr <- sapply(hdr, split_line, " = ", USE.NAMES = FALSE) + names(hdr) <- tolower(names(hdr)) + + ## process numeric values + tmp <- names(hdr) %in% c( + "samples", "lines", "bands", "header offset", "data type", + "byte order", "default bands", "data ignore value", + "wavelength", "fwhm", "data gain values" + ) + hdr [tmp] <- lapply(hdr [tmp], function(x) { + as.numeric(unlist(strsplit(x, ","))) + }) + + return(hdr) +} + +#" ENVI functions +#" +#" based on https: / / github.com / cran / hyperSpec / blob / master / R / read.ENVI.R +#" added wavelength, fwhm, ... to header reading +#" Title +#" +#" @param x character. +#" @param separator character +#" @param trim_blank boolean. +#" +#" @return list. +#" @export +split_line <- function(x, separator, trim_blank = TRUE) { + tmp <- regexpr(separator, x) + key <- substr(x, 1, tmp - 1) + value <- substr(x, tmp + 1, nchar(x)) + if (trim_blank) { + blank_pattern <- "^[[:blank:]]*([^[:blank:]] + .*[^[:blank:]] + )[[:blank:]]*$" + key <- sub(blank_pattern, "\\1", key) + value <- sub(blank_pattern, "\\1", value) + } + value <- as.list(value) + names(value) <- key + return(value) +} + +#" This function performs full training for hybrid invrsion using SVR with +#" values for default parameters +#" +#" @param minval list. minimum value for input parameters sampled to produce a training LUT +#" @param maxval list. maximum value for input parameters sampled to produce a training LUT +#" @param typedistrib list. Type of distribution. Either "Uniform" or "Gaussian" +#" @param gaussiandistrib list. Mean value and STD corresponding to the parameters sampled with gaussian distribution +#" @param parmset list. list of input parameters set to a specific value +#" @param nbsamples numeric. number of samples in training LUT +#" @param nbsamplesperrun numeric. number of training sample per individual regression model +#" @param nbmodels numeric. number of individual models to be run for ensemble +#" @param replacement bolean. is there replacement in subsampling? +#" @param sailversion character. Either 4SAIL or 4SAIL2 +#" @param parms2estimate list. list of input parameters to be estimated +#" @param bands2select list. list of bands used for regression for each input parameter +#" @param noiselevel list. list of noise value added to reflectance (defined per input parm) +#" @param specprospect list. Includes optical constants required for PROSPECT +#" @param specsoil list. Includes either dry soil and wet soil, or a unique soil sample if the psoil parameter is not inverted +#" @param specatm list. Includes direct and diffuse radiation for clear conditions +#" @param path_results character. path for results +#" @param figplot boolean. Set TRUE to get scatterplot of estimated biophysical variable during training step +#" @param force4lowlai boolean. Set TRUE to artificially reduce leaf chemical constituent content for low LAI +#" +#" +#" @return modelssvr list. regression models trained for the retrieval of inputvar based on brf_lut +#" @export + +train_prosail_inversion <- function(minval = NULL, maxval = NULL, + typedistrib = NULL, gaussiandistrib = NULL, parmset = NULL, + nbsamples = 2000, nbsamplesperrun = 100, nbmodels = 20, replacement = TRUE, + sailversion = "4SAIL", + parms2estimate = "lai", bands2select = NULL, noiselevel = NULL, + specprospect = NULL, specsoil = NULL, specatm = NULL, + path_results = "./", figplot = FALSE, force4lowlai = TRUE) { + + ###===================================================================### + ### 1- PRODUCE A LUT TO TRAIN THE HYBRID INVERSION ### + ###===================================================================### + # Define sensor characteristics + if (is.null(specprospect)) { + specprospect <- prosail::specprospect + } + if (is.null(specsoil)) { + specsoil <- prosail::specsoil + } + if (is.null(specprospect)) { + specatm <- prosail::specatm + } + # define distribution for parameters to be sampled + if (is.null(typedistrib)) { + typedistrib <- data.frame("CHL" = "Uniform", "CAR" = "Uniform", "EWT" = "Uniform", "ANT" = "Uniform", "LMA" = "Uniform", "N" = "Uniform", "BROWN" = "Uniform", + "psoil" = "Uniform", "LIDFa" = "Uniform", "lai" = "Uniform", "q" = "Uniform", "tto" = "Uniform", "tts" = "Uniform", "psi" = "Uniform") + } + if (is.null(gaussiandistrib)) { + gaussiandistrib <- list("Mean" = NULL, "Std" = NULL) + } + if (is.null(minval)) { + minval <- data.frame("CHL" = 10, "CAR" = 0, "EWT" = 0.01, "ANT" = 0, "LMA" = 0.005, "N" = 1.0, "psoil" = 0.0, "BROWN" = 0.0, + "LIDFa" = 20, "lai" = 0.5, "q" = 0.1, "tto" = 0, "tts" = 20, "psi" = 80) + } + if (is.null(maxval)) { + maxval <- data.frame("CHL" = 75, "CAR" = 15, "EWT" = 0.03, "ANT" = 2, "LMA" = 0.03, "N" = 2.0, "psoil" = 1.0, "BROWN" = 0.5, + "LIDFa" = 70, "lai" = 7, "q" = 0.2, "tto" = 5, "tts" = 30, "psi" = 110) + } + # define min and max values + # fixed parameters + if (is.null(parmset)) { + parmset <- data.frame("TypeLidf" = 2, "alpha" = 40) + } + # produce input parameters distribution + if (sailversion == "4SAIL") { + inputprosail <- get_distribution_input_prosail(minval, maxval, parmset, nbsamples, + typedistrib = typedistrib, + Mean = gaussiandistrib$Mean, Std = gaussiandistrib$Std, + force4lowlai = force4lowlai) + } else if (sailversion == "4SAIL2") { + inputprosail <- get_distribution_input_prosail2(minval, maxval, parmset, nbsamples, + typedistrib = typedistrib, + Mean = gaussiandistrib$Mean, Std = gaussiandistrib$Std, + force4lowlai = force4lowlai) + } + if (sailversion == "4SAIL2") { + # Definition of Cv && update LAI + maxlai <- min(c(maxval$lai), 4) + inputprosail$Cv <- NA * inputprosail$lai + inputprosail$Cv[which(inputprosail$lai > maxlai)] <- 1 + inputprosail$Cv[which(inputprosail$lai <= maxlai)] <- (1 / maxlai) + inputprosail$lai[which(inputprosail$lai <= maxlai)] / (maxlai + 1) + inputprosail$Cv <- inputprosail$Cv * matrix(rnorm(length(inputprosail$Cv), mean = 1, sd = 0.1)) + inputprosail$Cv[which(inputprosail$Cv < 0)] <- 0 + inputprosail$Cv[which(inputprosail$Cv > 1)] <- 1 + inputprosail$Cv[which(inputprosail$lai > maxlai)] <- 1 + inputprosail$fraction_brown <- 0 + 0 * inputprosail$lai + inputprosail$diss <- 0 + 0 * inputprosail$lai + inputprosail$Zeta <- 0.2 + 0 * inputprosail$lai + inputprosail$lai <- inputprosail$lai * inputprosail$Cv + } + + # generate LUT of BRF corresponding to inputprosail, for a sensor + brf_lut <- Generate_LUT_BRF(sailversion = sailversion, inputprosail = inputprosail, + specprospect = specprospect, specsoil = specsoil, specatm = specatm) + + # write parameters LUT + output <- matrix(unlist(inputprosail), ncol = length(inputprosail), byrow = FALSE) + filename <- file.path(path_results, "PROSAIL_LUT_InputParms.txt") + write.table(x = format(output, digits = 3), file = filename, append = FALSE, quote = FALSE, + col.names = names(inputprosail), row.names = FALSE, sep = "\t") + # Write BRF LUT corresponding to parameters LUT + filename <- file.path(path_results, "PROSAIL_LUT_reflectance.txt") + write.table(x = format(t(brf_lut), digits = 5), file = filename, append = FALSE, quote = FALSE, + col.names = specprospect$lambda, row.names = FALSE, sep = "\t") + + # Which bands will be used for inversion? + if (is.null(bands2select)) { + bands2select <- list() + for (parm in parms2estimate) { + bands2select[[parm]] <- seq(1, length(specprospect$lambda)) + } + } + # Add gaussian noise to reflectance LUT: one specific LUT per parameter + if (is.null(noiselevel)) { + noiselevel <- list() + for (parm in parms2estimate) { + noiselevel[[parm]] <- 0.01 + } + } + + # produce LIT with noise + brf_lut_noise <- list() + for (parm in parms2estimate) { + brf_lut_noise[[parm]] <- brf_lut[bands2select[[parm]], ] + brf_lut[bands2select[[parm]], ] * matrix(rnorm(nrow(brf_lut[bands2select[[parm]], ]) * ncol(brf_lut[bands2select[[parm]], ]), + 0, noiselevel[[parm]]), nrow = nrow(brf_lut[bands2select[[parm]], ])) + } + + ###===================================================================### + ### PERFORM HYBRID INVERSION ### + ###===================================================================### + # train SVR for each variable and each run + modelsvr <- list() + for (parm in parms2estimate) { + colparm <- which(parm == names(inputprosail)) + inputvar <- inputprosail[[colparm]] + modelsvr[[parm]] <- prosail_hybrid_train(brf_lut = brf_lut_noise[[parm]], inputvar = inputvar, + figplot = figplot, nbensemble = nbmodels, withreplacement = replacement) + } + return(modelsvr) +} + +#" writes ENVI hdr file +#" +#" @param hdr content to be written +#" @param hdrpath Path of the hdr file +#" +#" @return None +#" @importFrom stringr str_count +#" @export +write_envi_header <- function(hdr, hdrpath) { + h <- lapply(hdr, function(x) { + if (length(x) > 1 || (is.character(x) && stringr::str_count(x, "\\w + ") > 1)) { + x <- paste0("{", paste(x, collapse = ","), "}") + } + # convert last numerics + x <- as.character(x) + }) + writeLines(c("ENVI", paste(names(hdr), h, sep = "=")), con = hdrpath) + return(invisible()) +} diff -r 000000000000 -r 33a1e15f7252 prosail-master/R/Lib_SpectralIndices.R --- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/prosail-master/R/Lib_SpectralIndices.R Mon Jan 09 13:37:05 2023 +0000 @@ -0,0 +1,679 @@ +# ============================================================================== = +# prosail +# Lib_spectralindices.R +# ============================================================================== = +# PROGRAMMERS: +# Jean-Baptiste FERET +# Florian de BOISSIEU +# Copyright 2019/11 Jean-Baptiste FERET +# ============================================================================== = +# This Library includes aims at computing spectral indices from reflectance data +# ============================================================================== = + +#" This function computes Area under curve for continuum removed reflectances +#" See Malenovský et al. (2013) for details +#" http://dx.doi.org/10.1016/j.rse.2012.12.015 +#" +#" @param refl RasterBrick, RasterStack or list. Raster bands in the order of sensorbands. +#" @param sensorbands numeric. vector containing central wavelength for each spectral band in the image +#" @param aucminmax list. wavelengths of lower and upper boundaries ("CRmin" and "CRmax") +#" @param reflfactor numeric. multiplying factor used to write reflectance in image (==10000 for S2) +#" +#" @return aucval raster +#" @export +auc <- function(refl, sensorbands, aucminmax, reflfactor = 1) { + + aucbands <- list() + aucbands[["CRmin"]] <- sensorbands[get_closest_bands(sensorbands, aucminmax[["CRmin"]])] + aucbands[["CRmax"]] <- sensorbands[get_closest_bands(sensorbands, aucminmax[["CRmax"]])] + bands <- get_closest_bands(sensorbands, aucbands) + for (i in bands[["CRmin"]]:bands[["CRmax"]]) { + if (is.na(match(i, bands))) { + aucbands[[paste("B", i, sep = "")]] <- sensorbands[i] + } + } + # compute continuum removal for all spectral bands + cr <- cr_wl(refl = refl, sensorbands = sensorbands, + crbands = aucbands, reflfactor = reflfactor) + + wl <- sort(unlist(aucbands), decreasing = FALSE) + aucval <- 0.5 * (1 - cr[[1]]) * (wl[2] - wl[1]) + for (i in 2:length(cr)) { + aucval <- aucval + 0.5 * (2 - cr[[i - 1]] - cr[[i]]) * (wl[i + 1] - wl[i]) + } + aucval <- aucval + 0.5 * (1 - cr[[length(cr)]]) * (wl[i + 2] - wl[i + 1]) + return(aucval) +} + +#" This function extracts boundaries to be used to compute continuum from reflectance data +#" +#" @param refl RasterBrick, RasterStack or list. Raster bands in the order of sensorbands. +#" @param sensorbands numeric. vector containing central wavelength for each spectral band in the image +#" @param crbands list. list of spectral bands (central wavelength) including CRmin and CRmax +#" @param reflfactor numeric. multiplying factor used to write reflectance in image ( == 10000 for S2) +#" +#" @return crminmax list. list of rasters corresponding to minimum and maximum wavelengths +#" @export +crbound <- function(refl, sensorbands, crbands, reflfactor = 1) { + + # get closest spectral bands from CR1 and CR2 + bands <- get_closest_bands(sensorbands, list(crbands[["CRmin"]], crbands[["CRmax"]])) + wl <- sensorbands[bands] + # get equation for line going from CR1 to CR2 + crminmax <- readrasterbands(refl = refl, bands = bands, reflfactor = reflfactor) + names(crminmax) <- paste("wl_", as.character(wl), sep = "") + return(crminmax) +} + +#" This function extracts boundaries to be used to compute continuum from reflectance data +#" +#" @param refl RasterBrick, RasterStack or list. Raster bands in the order of sensorbands. +#" @param sensorbands numeric. vector containing central wavelength for each spectral band in the image +#" @param crbands list. list of spectral bands (central wavelength) including CRmin and CRmax +#" @param reflfactor numeric. multiplying factor used to write reflectance in image ( == 10000 for S2) +#" +#" @return outlier_iqr numeric. band numbers of original sensor corresponding to S2 +#" @importFrom progress progress_bar +#" @export +cr_wl <- function(refl, sensorbands, crbands, reflfactor = 1) { + + # Make sure CRmin and CRmax are correctly defined + if (is.na(match("CRmin", names(crbands))) || is.na(match("CRmax", names(crbands)))) { + stop("Please define CRmin and CRmax (CRmin0 in order to avoid problems + selzero <- which(refl == 0) + refl[selzero] <- 0.005 + if (dim(refl)[1] == length(sensorbands)) { + refl <- t(refl) + } + + # inelegant but meeeeh + listindices <- list("ARI1", "ARI2", "ARVI", "BAI", "BAIS2", "CHL_RE", "CRI1", "CRI2", "EVI", "EVI2", + "GRVI1", "GNDVI", "IRECI", "LAI_SAVI", "MCARI", "mNDVI705", "MSAVI2", + "MSI", "mSR705", "MTCI", "nBR_RAW", "NDI_45", "NDII", "NDVI", "NDVI_G", + "NDVI705", "NDWI1", "NDWI2", "PSRI", "PSRI_NIR", "RE_NDVI", "RE_NDWI", "S2REP", + "SAVI", "SIPI", "SR", "CR_SWIR") + if (sel_indices == "ALL") { + sel_indices <- listindices + } + if ("ARI1" %in% sel_indices) { + ari1 <- (1 / refl[, sen2s2[["B3"]]]) - (1 / refl[, sen2s2[["B5"]]]) + spectralindices$ARI1 <- ari1 + } + if ("ARI2" %in% sel_indices) { + ari2 <- (refl[, sen2s2[["B8"]]] / refl[, sen2s2[["B2"]]]) - (refl[, sen2s2[["B8"]]] / refl[, sen2s2[["B3"]]]) + spectralindices$ARI2 <- ari2 + } + if ("ARVI" %in% sel_indices) { + arvi <- (refl[, sen2s2[["B8"]]] - (2 * refl[, sen2s2[["B4"]]] - refl[, sen2s2[["B2"]]])) / (refl[, sen2s2[["B8"]]] + (2 * refl[, sen2s2[["B4"]]] - refl[, sen2s2[["B2"]]])) + spectralindices$ARVI <- arvi + } + if ("BAI" %in% sel_indices) { + bai <- (1 / ((0.1 - refl[, sen2s2[["B4"]]])**2 + (0.06 - refl[, sen2s2[["B8"]]])**2)) + spectralindices$BAI <- bai + } + if ("BAIS2" %in% sel_indices) { + bais2 <- (1 - ((refl[, sen2s2[["B6"]]] * refl[, sen2s2[["B7"]]] * refl[, sen2s2[["B8A"]]]) / refl[, sen2s2[["B4"]]])**0.5) * ((refl[, sen2s2[["B12"]]] - refl[, sen2s2[["B8A"]]]) / ((refl[, sen2s2[["B12"]]] + refl[, sen2s2[["B8A"]]])**0.5) + 1) + spectralindices$BAIS2 <- bais2 + } + if ("CCCI" %in% sel_indices) { + ccci <- ((refl[, sen2s2[["B8"]]] - refl[, sen2s2[["B5"]]]) / (refl[, sen2s2[["B8"]]] + refl[, sen2s2[["B5"]]])) / ((refl[, sen2s2[["B8"]]] - refl[, sen2s2[["B4"]]]) / (refl[, sen2s2[["B8"]]] + refl[, sen2s2[["B4"]]])) + spectralindices$CCCI <- ccci + } + if ("CHL_RE" %in% sel_indices) { + chl_re <- refl[, sen2s2[["B5"]]] / refl[, sen2s2[["B8"]]] + spectralindices$CHL_RE <- chl_re + } + if ("CRI1" %in% sel_indices) { + cri1 <- (1 / refl[, sen2s2[["B2"]]]) - (1 / refl[, sen2s2[["B3"]]]) + spectralindices$CRI1 <- cri1 + } + if ("CRI2" %in% sel_indices) { + cri2 <- (1 / refl[, sen2s2[["B2"]]]) - (1 / refl[, sen2s2[["B5"]]]) + spectralindices$CRI2 <- cri2 + } + if ("EVI" %in% sel_indices) { + evi <- 2.5 * (refl[, sen2s2[["B8"]]] - refl[, sen2s2[["B4"]]]) / ((refl[, sen2s2[["B8"]]] + 6 * refl[, sen2s2[["B4"]]] - 7.5 * refl[, sen2s2[["B2"]]] + 1)) + spectralindices$EVI <- evi + } + if ("EVI2" %in% sel_indices) { + evi2 <- 2.5 * (refl[, sen2s2[["B8"]]] - refl[, sen2s2[["B4"]]]) / (refl[, sen2s2[["B8"]]] + 2.4 * refl[, sen2s2[["B4"]]] + 1) + spectralindices$EVI2 <- evi2 + } + if ("GRVI1" %in% sel_indices) { + grvi1 <- (refl[, sen2s2[["B4"]]] - refl[, sen2s2[["B3"]]]) / (refl[, sen2s2[["B4"]]] + refl[, sen2s2[["B3"]]]) + spectralindices$GRVI1 <- grvi1 + } + if ("GNDVI" %in% sel_indices) { + gndvi <- (refl[, sen2s2[["B8"]]] - refl[, sen2s2[["B3"]]]) / (refl[, sen2s2[["B8"]]] + refl[, sen2s2[["B3"]]]) + spectralindices$GNDVI <- gndvi + } + if ("IRECI" %in% sel_indices) { + ireci <- (refl[, sen2s2[["B7"]]] - refl[, sen2s2[["B4"]]]) * (refl[, sen2s2[["B6"]]] / (refl[, sen2s2[["B5"]]])) + spectralindices$IRECI <- ireci + } + if ("LAI_SAVI" %in% sel_indices) { + lai_savi <- - log(0.371 + 1.5 * (refl[, sen2s2[["B8"]]] - refl[, sen2s2[["B4"]]]) / (refl[, sen2s2[["B8"]]] + refl[, sen2s2[["B4"]]] + 0.5)) / 2.4 + spectralindices$LAI_SAVI <- lai_savi + } + if ("MCARI" %in% sel_indices) { + mcari <- (1 - 0.2 * (refl[, sen2s2[["B5"]]] - refl[, sen2s2[["B3"]]]) / (refl[, sen2s2[["B5"]]] - refl[, sen2s2[["B4"]]])) + spectralindices$MCARI <- mcari + } + if ("mNDVI705" %in% sel_indices) { + mndvi705 <- (refl[, sen2s2[["B6"]]] - refl[, sen2s2[["B5"]]]) / (refl[, sen2s2[["B6"]]] + refl[, sen2s2[["B5"]]] - 2 * refl[, sen2s2[["B2"]]]) + spectralindices$mNDVI705 <- mndvi705 + } + if ("MSAVI2" %in% sel_indices) { + msavi2 <- ((refl[, sen2s2[["B8"]]] + 1) - 0.5 * sqrt(((2 * refl[, sen2s2[["B8"]]]) - 1)**2 + 8 * refl[, sen2s2[["B4"]]])) + spectralindices$MSAVI2 <- msavi2 + } + if ("MSI" %in% sel_indices) { + msi <- refl[, sen2s2[["B11"]]] / refl[, sen2s2[["B8"]]] + spectralindices$MSI <- msi + } + if ("mSR705" %in% sel_indices) { + msr705 <- (refl[, sen2s2[["B6"]]] - refl[, sen2s2[["B2"]]]) / (refl[, sen2s2[["B5"]]] - refl[, sen2s2[["B2"]]]) + spectralindices$mSR705 <- msr705 + } + if ("MTCI" %in% sel_indices) { + mtci <- (refl[, sen2s2[["B6"]]] - refl[, sen2s2[["B5"]]]) / (refl[, sen2s2[["B5"]]] + refl[, sen2s2[["B4"]]]) + spectralindices$MTCI <- mtci + } + if ("nBR_RAW" %in% sel_indices) { + nbr_raw <- (refl[, sen2s2[["B8"]]] - refl[, sen2s2[["B12"]]]) / (refl[, sen2s2[["B8"]]] + refl[, sen2s2[["B12"]]]) + spectralindices$nBR_RAW <- nbr_raw + } + if ("NDI_45" %in% sel_indices) { + ndi_45 <- (refl[, sen2s2[["B5"]]] - refl[, sen2s2[["B4"]]]) / (refl[, sen2s2[["B5"]]] + refl[, sen2s2[["B4"]]]) + spectralindices$NDI_45 <- ndi_45 + } + if ("NDII" %in% sel_indices) { + ndii <- (refl[, sen2s2[["B8"]]] - refl[, sen2s2[["B11"]]]) / (refl[, sen2s2[["B8"]]] + refl[, sen2s2[["B11"]]]) + spectralindices$NDII <- ndii + } + if ("NDSI" %in% sel_indices) { + ndisi <- (refl[, sen2s2[["B3"]]] - refl[, sen2s2[["B11"]]]) / (refl[, sen2s2[["B3"]]] + refl[, sen2s2[["B11"]]]) + spectralindices$NDSI <- ndsi + } + if ("NDVI" %in% sel_indices) { + ndvi <- (refl[, sen2s2[["B8"]]] - refl[, sen2s2[["B4"]]]) / (refl[, sen2s2[["B8"]]] + refl[, sen2s2[["B4"]]]) + spectralindices$NDVI <- ndvi + } + if ("NDVI_G" %in% sel_indices) { + ndvi_g <- refl[, sen2s2[["B3"]]] * (refl[, sen2s2[["B8"]]] - refl[, sen2s2[["B4"]]]) / (refl[, sen2s2[["B8"]]] + refl[, sen2s2[["B4"]]]) + spectralindices$NDVI_G <- ndvi_g + } + if ("NDVI705" %in% sel_indices) { + ndvi705 <- (refl[, sen2s2[["B6"]]] - refl[, sen2s2[["B5"]]]) / (refl[, sen2s2[["B6"]]] + refl[, sen2s2[["B5"]]]) + spectralindices$NDVI705 <- ndvi705 + } + if ("NDWI1" %in% sel_indices) { + ndwi1 <- (refl[, sen2s2[["B8A"]]] - refl[, sen2s2[["B11"]]]) / (refl[, sen2s2[["B8A"]]] + refl[, sen2s2[["B11"]]]) + spectralindices$NDWI1 <- ndwi1 + } + if ("NDWI2" %in% sel_indices) { + ndwi2 <- (refl[, sen2s2[["B8A"]]] - refl[, sen2s2[["B12"]]]) / (refl[, sen2s2[["B8A"]]] + refl[, sen2s2[["B12"]]]) + spectralindices$NDWI2 <- ndwi2 + } + if ("PSRI" %in% sel_indices) { + psri <- (refl[, sen2s2[["B4"]]] - refl[, sen2s2[["B2"]]]) / (refl[, sen2s2[["B5"]]]) + spectralindices$PSRI <- psri + } + if ("PSRI_NIR" %in% sel_indices) { + psri_nir <- (refl[, sen2s2[["B4"]]] - refl[, sen2s2[["B2"]]]) / (refl[, sen2s2[["B8"]]]) + spectralindices$PSRI_NIR <- psri_nir + } + if ("RE_NDVI" %in% sel_indices) { + re_ndvi <- (refl[, sen2s2[["B8"]]] - refl[, sen2s2[["B6"]]]) / (refl[, sen2s2[["B8"]]] + refl[, sen2s2[["B6"]]]) + spectralindices$RE_NDVI <- re_ndvi + } + if ("RE_NDWI" %in% sel_indices) { + re_ndwi <- (refl[, sen2s2[["B4"]]] - refl[, sen2s2[["B6"]]]) / (refl[, sen2s2[["B4"]]] + refl[, sen2s2[["B6"]]]) + spectralindices$RE_NDWI <- re_ndwi + } + if ("S2REP" %in% sel_indices) { + s2rep <- 705 + 35 * (0.5 * (refl[, sen2s2[["B8"]]] + refl[, sen2s2[["B5"]]]) - refl[, sen2s2[["B6"]]]) / (refl[, sen2s2[["B7"]]] - refl[, sen2s2[["B6"]]]) + spectralindices$S2REP <- s2rep + } + if ("SAVI" %in% sel_indices) { + savi <- 1.5 * (refl[, sen2s2[["B8"]]] - refl[, sen2s2[["B5"]]]) / (refl[, sen2s2[["B8"]]] + refl[, sen2s2[["B5"]]] + 0.5) + spectralindices$SAVI <- savi + } + if ("SIPI" %in% sel_indices) { + sipi <- (refl[, sen2s2[["B8"]]] - refl[, sen2s2[["B2"]]]) / (refl[, sen2s2[["B8"]]] - refl[, sen2s2[["B4"]]]) + spectralindices$SIPI <- sipi + } + if ("SR" %in% sel_indices) { + sr <- refl[, sen2s2[["B8"]]] / refl[, sen2s2[["B4"]]] + spectralindices$SR <- sr + } + if ("CR_SWIR" %in% sel_indices) { + cr_swir <- refl[, sen2s2[["B11"]]] / (refl[, sen2s2[["B8A"]]] + (s2bands$B11 - s2bands$B8A) * (refl[, sen2s2[["B12"]]] - refl[, sen2s2[["B8A"]]]) / (s2bands$B12 - s2bands$B8A)) + spectralindices$CR_SWIR <- cr_swir + } + res <- list("spectralindices" = spectralindices, "listindices" = listindices) + return(res) +} + +#" this function identifies the bands of a given sensor with closest match to its spectral characteristics +#" +#" @param sensorbands numeric. wavelength in nanometer of the sensor of interest +#" @param listbands numeric or list. Named vector or list of spectral bands corresponding to sensor +#" +#" @return numeric. band numbers of original sensor +#" @export +get_closest_bands <- function(sensorbands, listbands) { + sapply(listbands, function(x) { + b <- which.min(abs(sensorbands - x)) + names(b) <- "" + b + }) +} + +#" This function computes interquartile range (IQR) criterion, which can be used +#" as a criterion for outlier detection +#" +#" @param distval numeric. vector of distribution of values +#" @param weightirq numeric. weighting factor appplied to IRQ to define lower and upper boudaries for outliers +#" +#" @return outlier_iqr numeric. band numbers of original sensor corresponding to S2 +#" @importFrom stats IQR quantile +#" @export +iqr_outliers <- function(distval, weightirq = 1.5) { + iqr <- IQR(distval, na.rm = TRUE) + range_iqr <- c(quantile(distval, 0.25, na.rm = TRUE), quantile(distval, 0.75, na.rm = TRUE)) + outlier_iqr <- c(range_iqr[1] - weightirq * iqr, range_iqr[2] + weightirq * iqr) + return(outlier_iqr) +} + +#" This function selects bands from a raster or stars object +#" +#" @param refl RasterBrick, RasterStack or list. Raster bands in the order of sensorbands. +#" @param bands numeric. rank of bands to be read in refl +#" @param reflfactor numeric. multiplying factor used to write reflectance in image ( == 10000 for S2) +#" +#" @return robj list. R object (default is raster, stars if refl is stars object) +#" @importFrom raster subset stack +#" @export +readrasterbands <- function(refl, bands, reflfactor = 1) { + + # get equation for line going from CR1 to CR2 + classraster <- class(refl) + if (classraster == "RasterBrick" || classraster == "RasterStack" || classraster == "stars") { + # if !reflfactor == 1 then apply a reflectance factor + if (classraster == "stars") { + robj <- refl[bands] + } else { + robj <- raster::subset(refl, bands) + } + if (!reflfactor == 1) { + robj <- robj / reflfactor + } + } else if (is.list(refl)) { + robj <- raster::stack(refl[bands]) # checks that all rasters have same crs/extent + if (!reflfactor == 1) { + robj <- robj / reflfactor + } + } else { + stop("refl is expected to be a RasterStack, RasterBrick, Stars object or a list of rasters") + } + return(robj) +} diff -r 000000000000 -r 33a1e15f7252 test-data/12a0b625-9ad5-4251-a57a-305e22edef2e.xml --- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/test-data/12a0b625-9ad5-4251-a57a-305e22edef2e.xml Mon Jan 09 13:37:05 2023 +0000 @@ -0,0 +1,661 @@ + + + + 12a0b625-9ad5-4251-a57a-305e22edef2e + + + + + + + + + + + + + + Santiago Poggio + + + IFEVA/ Catédra de producción vegetal, facultad de agronomia, Universidad de Buenos Aires/ CONICET + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + spoggio@agro.uba.ar + + + + + + + + + + + + + + Jacques Baudry + + + BAGAP UMR 0980 INRAE Agrocampus Ouest ESA + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + jacques.baudry@inrae.fr + + + + + + + + + + + + + + Audrey Alignier + + + BAGAP UMR 0980 INRAE Agrocampus Ouest ESA + + + + + + + audrey.alignier@inrae.fr + + + + + + + + + + + + + + + + + Zone Atelier Armorique (ZAAr) + + + + + + + + + + + + + + + + + + + 2021-03-27T00:00:09 + + + ISO 19115:2003/19139 + + + 1.0 + + + + + + + RGF Lambert-93 + + + + + + + + + + + Relevés floristiques en maïs (Pleine-Fougères, 2010) - Zone Atelier Armorique ZAAr + + + + + 2010-09-14 + + + + + + + + + + + + + https://www.osuris.fr/geonetwork/srv/metadata/12a0b625-9ad5-4251-a57a-305e22edef2e + + + + + + + + + + "Relevés des adventices en cultures de maïs (2010) ZAAr" + +Relevés des adventices dans 28 parcelles de maïs pour séparer les effets de la séquence des cultures de l'hétérogénéité spatio-temporelle du paysage des 10 dernières années. + +Ce projet a été financé en partenariat par : +MINCyT: Ministerio de ciencia, tecnologia e innovation productiva (Argentine) +ECOS-SUD (France) + + + + + + + + + + + Santiago Poggio + + + IFEVA/ Catédra de producción vegetal, facultad de agronomia, Universidad de Buenos Aires/ CONICET + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + spoggio@agro.uba.ar + + + + + + + + + + + + + + Jacques Baudry + + + BAGAP UMR 0980 INRAE Agrocampus Ouest ESA + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + jacques.baudry@inrae.fr + + + + + + + + + + + + + + + + + + + + + https://www.osuris.fr/geonetwork/srv/api/records/12a0b625-9ad5-4251-a57a-305e22edef2e/attachments/sad_21_s.png + + + thumbnail + + + png + + + + + + + https://www.osuris.fr/geonetwork/srv/api/records/12a0b625-9ad5-4251-a57a-305e22edef2e/attachments/sad_21.png + + + large_thumbnail + + + png + + + + + + + Biodiversité + + + + + + + + + + Maïs + + + + + + + + + + Forêt / milieu végétal + + + Agriculture + + + Ecologie et environnement + + + Paysages et sites + + + + + + + + theme.EnvironnementFR.rdf + + + + + 2017-03-20 + + + + + + + + + + geonetwork.thesaurus.external.theme.EnvironnementFR + + + + + + + + + + + Installations de suivi environnemental + + + Habitats et biotopes + + + + + + + + Registre de thème INSPIRE + + + + + 2019-06-25 + + + + + + + + + + geonetwork.thesaurus.external.theme.httpinspireeceuropaeutheme-theme + + + + + + + + + + + + + + + + + licence CC-BY-NC 4.0 + + + + + + + Utilisation libre sous réserve de mentionner la source (a minima le nom du producteur) et la date de sa dernière mise à jour + + + + + + + + + + 20 + + + + + + + + + + + farming + + + + + + + + 2010-09-08 + 2008-09-14 + + + + + + + + + + + + -1.6259765625 + + + -0.9777832031250001 + + + 48.092651367188 + + + 48.696899414063 + + + + + + + France, Pleine-Fougères + + + + + + + + + ESRI Shapefile + + + 1.0 + + + + + + + + + + + + + + + + + + + + + + + + + L’article 7, paragraphe 1, de la directive 2007/2/CE correspond aux modalités techniques de l’interopérabilité : il s’agit du règlement relatif à l’interopérabilité : règlement n°1253/2013 du 21 octobre 2013 modifiant et complétant le règlement n°1089/2010 du 23 novembre 2010. + + + + + 2013-10-21 + + + + + + + + + + + + + true + + + + + + + + + Relevé sur le terrain des adventices du maïs + + + + + + \ No newline at end of file diff -r 000000000000 -r 33a1e15f7252 test-data/Metadata_validation.txt --- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/test-data/Metadata_validation.txt Mon Jan 09 13:37:05 2023 +0000 @@ -0,0 +1,5 @@ + +Validation of metadata according to ISO 19139 + +TRUE + according to ISO 19139 XML schemas! diff -r 000000000000 -r 33a1e15f7252 test-data/Mission.csv --- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/test-data/Mission.csv Mon Jan 09 13:37:05 2023 +0000 @@ -0,0 +1,2 @@ +"","x" +"1","SAFE" diff -r 000000000000 -r 33a1e15f7252 test-data/NDVI.tabular --- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/test-data/NDVI.tabular Mon Jan 09 13:37:05 2023 +0000 @@ -0,0 +1,10001 @@ +S2A_Subset longitude latitude NDVI +234.29 13.7115065213769 3.17883791054367 0.809475381273922 +233.06 13.7124063428304 3.17883903826377 0.814533326859802 +231.57 13.7133061646046 3.17884016519658 0.808063813546791 +228.73 13.7142059866993 3.17884129134209 0.814678963045019 +230.6 13.7151058091144 3.17884241670032 0.812649359747791 +228.85 13.7160056318495 3.17884354127124 0.806605795437084 +229.59 13.7169054549044 3.17884466505487 0.810899033966968 +239.74 13.7178052782789 3.1788457880512 0.808152735556578 +228.84 13.7187051019728 3.17884691026023 0.81364672485546 +217.93 13.7196049259859 3.17884803168196 0.821532180501305 +221.14 13.720504750318 3.17884915231639 0.813394469354217 +226.34 13.7214045749687 3.17885027216352 0.804053528518387 +233.05 13.722304399938 3.17885139122333 0.802659325445255 +237.25 13.7232042252255 3.17885250949585 0.809442899205139 +234.61 13.7241040508311 3.17885362698105 0.811580900151433 +225.7 13.7250038767545 3.17885474367895 0.820858536885687 +243.54 13.7259037029954 3.17885585958953 0.805156185849842 +238.98 13.7268035295538 3.17885697471281 0.814407496583588 +224.3 13.7277033564293 3.17885808904877 0.806504430597208 +229.94 13.7286031836218 3.17885920259741 0.814004957858205 +230.32 13.7295030111309 3.17886031535874 0.834195663335835 +221.94 13.7304028389565 3.17886142733275 0.830148226182174 +221.75 13.7313026670984 3.17886253851944 0.817970615615008 +231.52 13.7322024955563 3.17886364891882 0.826119282944004 +230.78 13.73310232433 3.17886475853087 0.837485155719081 +237.15 13.7340021534193 3.1788658673556 0.807358464103723 +240.64 13.7349019828239 3.178866975393 0.834367581945824 +240.36 13.7358018125437 3.17886808264308 0.814613959603203 +234.42 13.7367016425784 3.17886918910583 0.823334743713733 +232.98 13.7376014729278 3.17887029478125 0.812603727061501 +223.55 13.7385013035916 3.17887139966934 0.817053245524247 +228.45 13.7394011345697 3.1788725037701 0.820890651769377 +234.76 13.7403009658618 3.17887360708353 0.81472573939151 +241.63 13.7412007974676 3.17887470960963 0.800657983613983 +242.54 13.7421006293871 3.17887581134839 0.804551773444016 +233.03 13.7430004616199 3.17887691229981 0.818208709568542 +234.33 13.7439002941658 3.1788780124639 0.828198556142271 +224.33 13.7448001270246 3.17887911184064 0.815919459122387 +219.08 13.7456999601961 3.17888021043005 0.813250047953031 +223.36 13.74659979368 3.17888130823211 0.809531707397978 +231.08 13.7474996274761 3.17888240524683 0.806462838677604 +228.14 13.7483994615842 3.17888350147421 0.822623856627664 +223.55 13.7492992960042 3.17888459691424 0.824117178204669 +235.86 13.7501991307356 3.17888569156692 0.800303742692492 +241.66 13.7510989657784 3.17888678543225 0.803205534643691 +242.49 13.7519988011323 3.17888787851024 0.824298525547548 +241.99 13.752898636797 3.17888897080087 0.83021872061821 +239.49 13.7537984727725 3.17889006230415 0.824182760846283 +231.58 13.7546983090583 3.17889115302007 0.812953085714065 +239.36 13.7555981456544 3.17889224294864 0.7917462194466 +247.4 13.7564979825604 3.17889333208985 0.802430972507897 +242.26 13.7573978197762 3.17889442044371 0.814116487206741 +247.77 13.7582976573015 3.1788955080102 0.816578431872301 +247.25 13.7591974951362 3.17889659478933 0.819701083956995 +244.15 13.7600973332799 3.17889768078111 0.808361251426994 +235.55 13.7609971717325 3.17889876598551 0.814163958835801 +236.54 13.7618970104937 3.17889985040256 0.817860100896017 +259.75 13.7627968495633 3.17890093403223 0.795576202131322 +244.36 13.7636966889412 3.17890201687454 0.81506586995564 +235.82 13.764596528627 3.17890309892948 0.815240243897869 +233.5 13.7654963686205 3.17890418019705 0.828422528097906 +236.56 13.7663962089216 3.17890526067725 0.81758530183727 +235.9 13.7672960495299 3.17890634037008 0.821981600526329 +228.58 13.7681958904453 3.17890741927553 0.812693877551021 +230.77 13.7690957316676 3.17890849739361 0.814535088866951 +238.03 13.7699955731965 3.1789095747243 0.815205860065673 +249.26 13.7708954150318 3.17891065126763 0.797837005182844 +242.17 13.7717952571732 3.17891172702357 0.805513717788723 +239.97 13.7726950996206 3.17891280199213 0.819577189812926 +235.53 13.7735949423737 3.1789138761733 0.813865839229606 +236.81 13.7744947854324 3.1789149495671 0.810959376076675 +233.99 13.7753946287963 3.17891602217351 0.81434132996633 +226.56 13.7762944724653 3.17891709399253 0.82696447102568 +234.9 13.7771943164391 3.17891816502417 0.815875148162782 +243.18 13.7780941607174 3.17891923526842 0.810625802481329 +247.2 13.7789940053002 3.17892030472527 0.818079912683078 +244.53 13.7798938501872 3.17892137339474 0.800925637349623 +236.99 13.780793695378 3.17892244127681 0.813774947309153 +236.15 13.7816935408726 3.17892350837149 0.818908275384339 +244.48 13.7825933866707 3.17892457467878 0.81285030758715 +246.96 13.783493232772 3.17892564019866 0.822940109917245 +249.11 13.7843930791764 3.17892670493115 0.813028720820552 +243.31 13.7852929258836 3.17892776887624 0.826637668551544 +245.91 13.7861927728933 3.17892883203393 0.827443052849893 +244.28 13.7870926202055 3.17892989440422 0.820279603713555 +243.57 13.7879924678198 3.1789309559871 0.808850251453302 +237.38 13.7888923157359 3.17893201678258 0.820047373595924 +236.74 13.7897921639538 3.17893307679065 0.824470693434868 +237.08 13.7906920124732 3.17893413601132 0.814539306201743 +231.93 13.7915918612938 3.17893519444458 0.815760155511675 +233.3 13.7924917104154 3.17893625209042 0.815428377607499 +226.63 13.7933915598378 3.17893730894886 0.818582767494497 +225.4 13.7942914095608 3.17893836501988 0.804200341678165 +220.92 13.7951912595842 3.17893942030349 0.817102388424875 +226.88 13.7960911099076 3.17894047479969 0.799571082443848 +237.82 13.796990960531 3.17894152850847 0.788362376439417 +229.27 13.797890811454 3.17894258142983 0.80738022394191 +226.03 13.7987906626765 3.17894363356377 0.824131714120488 +226.14 13.7996905141983 3.17894468491029 0.815330900855561 +230.98 13.800590366019 3.1789457354694 0.808311508701371 +227.43 13.7115076435281 3.17793343739286 0.818219406213511 +237.82 13.7124074641984 3.17793456479146 0.80178405128955 +231.83 13.7133072851895 3.17793569140299 0.805308964660943 +236.23 13.7142071065011 3.17793681722745 0.807357072355933 +226.69 13.715106928133 3.17793794226484 0.809980033492206 +232.29 13.716006750085 3.17793906651517 0.816304281993822 +222.88 13.7169065723568 3.17794018997841 0.821086482404934 +236.22 13.7178063949482 3.17794131265459 0.806651307850236 +215.04 13.718706217859 3.17794243454369 0.821871568919564 +217.27 13.7196060410889 3.17794355564571 0.830374526226052 +223.88 13.7205058646378 3.17794467596066 0.827732730093467 +223.99 13.7214056885055 3.17794579548853 0.82023039219494 +228.84 13.7223055126916 3.17794691422931 0.810346347052084 +227.93 13.7232053371959 3.17794803218301 0.814443071049708 +236.67 13.7241051620184 3.17794914934964 0.782393959365668 +239.38 13.7250049871586 3.17795026572917 0.78587273299088 +249.23 13.7259048126164 3.17795138132162 0.795058850073328 +233.81 13.7268046383916 3.17795249612698 0.798622089830424 +244.63 13.727704464484 3.17795361014526 0.786546641843109 +225.24 13.7286042908933 3.17795472337644 0.805288324467868 +232.05 13.7295041176193 3.17795583582053 0.828534552981709 +226.54 13.7304039446617 3.17795694747753 0.826437978741478 +223.2 13.7313037720204 3.17795805834743 0.823886758147647 +225.87 13.7322035996952 3.17795916843024 0.819546299392629 +226.72 13.7331034276857 3.17796027772595 0.828981403227636 +228.92 13.7340032559919 3.17796138623456 0.828881231741952 +227.97 13.7349030846133 3.17796249395608 0.829264830593296 +235.8 13.7358029135499 3.17796360089049 0.825696232824114 +242.53 13.7367027428015 3.1779647070378 0.808492859600501 +241.93 13.7376025723677 3.177965812398 0.806587874378085 +234.57 13.7385024022484 3.1779669169711 0.820984978132725 +235.06 13.7394022324433 3.17796802075709 0.817574966623164 +239.26 13.7403020629522 3.17796912375598 0.814914406908044 +239.2 13.7412018937749 3.17797022596775 0.808311714499548 +238.82 13.7421017249112 3.17797132739242 0.793998820107004 +230.6 13.7430015563608 3.17797242802997 0.800489554758388 +224.86 13.7439013881235 3.17797352788041 0.811388579204165 +216.66 13.7448012201991 3.17797462694373 0.812031412814192 +213.08 13.7457010525874 3.17797572521994 0.82094831654322 +229.43 13.7466008852882 3.17797682270903 0.81117385691317 +234.38 13.7475007183011 3.177977919411 0.813709443380347 +237.28 13.7484005516261 3.17797901532585 0.818913599540023 +231.98 13.7493003852628 3.17798011045358 0.824918353064676 +237.51 13.7502002192111 3.17798120479419 0.823851716207545 +242.96 13.7511000534707 3.17798229834767 0.815022500156892 +236.79 13.7519998880414 3.17798339111403 0.826878850029681 +234.49 13.7528997229229 3.17798448309326 0.831109279200371 +240.7 13.7537995581152 3.17798557428536 0.822957103868777 +236.52 13.7546993936178 3.17798666469033 0.820434068940361 +237.43 13.7555992294307 3.17798775430817 0.814698852492894 +251.9 13.7564990655535 3.17798884313888 0.799049975336645 +250.57 13.7573989019861 3.17798993118246 0.809343392380383 +251.6 13.7582987387283 3.1779910184389 0.816970367847412 +249.23 13.7591985757797 3.1779921049082 0.810066307022736 +248.9 13.7600984131402 3.17799319059037 0.814272700103342 +240.64 13.7609982508096 3.17799427548539 0.834111832609323 +244.67 13.7618980887876 3.17799535959328 0.820927299703264 +249.13 13.7627979270741 3.17799644291402 0.81941723975237 +244.38 13.7636977656687 3.17799752544762 0.813053003663678 +235.83 13.7645976045713 3.17799860719408 0.820840302624146 +236.98 13.7654974437816 3.17799968815339 0.827024039789997 +239.22 13.7663972832994 3.17800076832555 0.827223774008696 +228.89 13.7672971231246 3.17800184771057 0.820663379298991 +235.27 13.7681969632568 3.17800292630844 0.809345999240672 +238.06 13.7690968036958 3.17800400411915 0.806985361112799 +247.47 13.7699966444415 3.17800508114271 0.815227219882709 +249.61 13.7708964854936 3.17800615737912 0.796140461879152 +247.74 13.7717963268518 3.17800723282837 0.816694575900983 +242.69 13.772696168516 3.17800830749047 0.800380692861007 +231.6 13.7735960104859 3.17800938136541 0.812093450809009 +232.59 13.7744958527613 3.17801045445319 0.811093135198834 +230.25 13.775395695342 3.17801152675381 0.804519665965449 +231.16 13.7762955382277 3.17801259826727 0.815290383050285 +229.96 13.7771953814183 3.17801366899356 0.821960638664762 +244.86 13.7780952249135 3.17801473893269 0.821713925374952 +246.48 13.778995068713 3.17801580808466 0.801501720556287 +255.46 13.7798949128167 3.17801687644946 0.791764890774792 +250.28 13.7807947572244 3.17801794402709 0.804506189885381 +237.5 13.7816946019357 3.17801901081755 0.812207040225483 +240.15 13.7825944469506 3.17802007682084 0.81877897418428 +235.21 13.7834942922687 3.17802114203695 0.817288568176679 +243.16 13.7843941378898 3.1780222064659 0.81435868650014 +232.31 13.7852939838137 3.17802327010767 0.818506946039915 +238.61 13.7861938300403 3.17802433296226 0.831224161771002 +231.75 13.7870936765692 3.17802539502967 0.810286485082697 +230.93 13.7879935234002 3.17802645630991 0.815151583353965 +224.61 13.7888933705332 3.17802751680297 0.823969516709067 +231.16 13.7897932179678 3.17802857650884 0.815176164322186 +236.69 13.7906930657039 3.17802963542753 0.817237260249273 +230.63 13.7915929137413 3.17803069355904 0.817315280938479 +233.51 13.7924927620796 3.17803175090336 0.80520877498783 +229.52 13.7933926107188 3.1780328074605 0.80791000761035 +219.51 13.7942924596586 3.17803386323045 0.808085499948618 +222.8 13.7951923088986 3.17803491821321 0.814799127553706 +223.53 13.7960921584389 3.17803597240878 0.822096184812408 +231.84 13.796992008279 3.17803702581715 0.809249126638418 +234.92 13.7978918584188 3.17803807843834 0.812938431460045 +233.03 13.798791708858 3.17803913027232 0.814938277833185 +229.8 13.7996915595965 3.17804018131912 0.80503481949892 +233.62 13.800591410634 3.17804123157871 0.816237503786731 +228.63 13.7115087653583 3.17702896422579 0.810060157153215 +235.22 13.7124085852458 3.17703009130288 0.813624508867744 +239.86 13.713308405454 3.17703121759314 0.812611476777603 +235.06 13.7142082259827 3.17703234309654 0.812735252434434 +233.04 13.7151080468317 3.17703346781311 0.816553043531073 +226.77 13.7160078680007 3.17703459174282 0.82484197643266 +232.17 13.7169076894896 3.17703571488569 0.825005097433806 +228.89 13.7178075112981 3.17703683724171 0.811535948359503 +217.79 13.718707333426 3.17703795881088 0.817739975698663 +220.07 13.719607155873 3.1770390795932 0.823981669465866 +218.34 13.720506978639 3.17704019958867 0.83089376464502 +231.65 13.7214068017237 3.17704131879727 0.839171953075545 +231.96 13.7223066251269 3.17704243721903 0.802148210492565 +231.12 13.7232064488483 3.17704355485392 0.814775492995535 +234.62 13.7241062728878 3.17704467170196 0.801040882616938 +231.13 13.7250060972451 3.17704578776313 0.796369315191413 +236.37 13.72590592192 3.17704690303745 0.801386537877263 +238.95 13.7268057469123 3.1770480175249 0.813725188016274 +239.33 13.7277055722218 3.17704913122549 0.80502748203098 +233.07 13.7286053978481 3.17705024413921 0.810051447626968 +229.14 13.7295052237912 3.17705135626606 0.839406046668737 +229.65 13.7304050500507 3.17705246760605 0.830971861182315 +231.02 13.7313048766265 3.17705357815916 0.810226803468759 +238.42 13.7322047035183 3.17705468792541 0.816492156997302 +228.21 13.7331045307259 3.17705579690478 0.835021294095506 +236.42 13.7340043582491 3.17705690509728 0.837584462932252 +233.39 13.7349041860876 3.1770580125029 0.83642671113719 +230.34 13.7358040142413 3.17705911912164 0.824285735756046 +229.42 13.7367038427099 3.17706022495351 0.82197673318831 +239.82 13.7376036714931 3.1770613299985 0.816958078163368 +236.91 13.7385035005909 3.17706243425661 0.818264734357303 +240.63 13.7394033300028 3.17706353772783 0.822457684640721 +240.99 13.7403031597288 3.17706464041217 0.82876856613013 +246.41 13.7412029897686 3.17706574230963 0.819629599061259 +232.62 13.7421028201219 3.1770668434202 0.807263161323951 +231.82 13.7430026507885 3.17706794374388 0.815980417520747 +225.78 13.7439024817683 3.17706904328067 0.82003771805752 +227.72 13.744802313061 3.17707014203058 0.800942394254598 +219.26 13.7457021446663 3.17707123999359 0.811316137242426 +238.05 13.7466019765841 3.1770723371697 0.815301868829203 +239.11 13.7475018088141 3.17707343355893 0.819827174112888 +241.53 13.7484016413561 3.17707452916125 0.834864630669603 +227.82 13.7493014742099 3.17707562397669 0.829111801332808 +230.14 13.7502013073752 3.17707671800522 0.82191362792117 +237.64 13.7511011408518 3.17707781124685 0.814143615286549 +228.79 13.7520009746396 3.17707890370158 0.814626963984734 +222.53 13.7529008087382 3.17707999536941 0.841945226235735 +238.29 13.7538006431474 3.17708108625033 0.832752444573531 +242.15 13.7547004778671 3.17708217634435 0.832020889587034 +247.92 13.755600312897 3.17708326565147 0.814058464647977 +250.21 13.7565001482369 3.17708435417167 0.813232159415418 +250.52 13.7573999838865 3.17708544190497 0.810792457539707 +240.85 13.7582998198457 3.17708652885135 0.809798771846953 +247.3 13.7591996561141 3.17708761501083 0.810485688633239 +251.18 13.7600994926917 3.17708870038338 0.81270958905105 +250.85 13.7609993295781 3.17708978496903 0.816891834480415 +246.76 13.7618991667731 3.17709086876776 0.820170343868729 +242.93 13.7627990042766 3.17709195177957 0.821913330819101 +234.1 13.7636988420882 3.17709303400447 0.830321455522298 +242.49 13.7645986802078 3.17709411544244 0.813361580123442 +243.33 13.7654985186352 3.17709519609349 0.811578260752097 +244 13.76639835737 3.17709627595762 0.809032135084905 +233.99 13.7672981964122 3.17709735503483 0.824912004359657 +238.62 13.7681980357614 3.17709843332511 0.813780163652473 +242.15 13.7690978754175 3.17709951082846 0.802976720314993 +244.4 13.7699977153801 3.17710058754489 0.80652395830111 +263.59 13.7708975556492 3.17710166347438 0.797664966734836 +253.41 13.7717973962244 3.17710273861695 0.829984981820098 +243.72 13.7726972371056 3.17710381297258 0.813198609724422 +237.16 13.7735970782926 3.17710488654128 0.822623877667599 +231.8 13.774496919785 3.17710595932305 0.816425772263561 +238.1 13.7753967615827 3.17710703131788 0.82407116729747 +238.42 13.7762966036854 3.17710810252577 0.825440097755832 +239.36 13.777196446093 3.17710917294673 0.81273829142924 +243.38 13.7780962888051 3.17711024258074 0.804854513646455 +244.29 13.7789961318217 3.17711131142782 0.803472478758774 +248.29 13.7798959751424 3.17711237948795 0.809320659536066 +242.35 13.780795818767 3.17711344676114 0.804760365502724 +233 13.7816956626954 3.17711451324738 0.816706342264779 +244.05 13.7825955069272 3.17711557894667 0.81660985889683 +243.98 13.7834953514623 3.17711664385902 0.816817645176595 +240.41 13.7843951963004 3.17711770798442 0.821396763332247 +229.6 13.7852950414413 3.17711877132287 0.827030851028552 +224.67 13.7861948868848 3.17711983387436 0.828523870888562 +220.74 13.7870947326307 3.17712089563891 0.828263383697071 +215.44 13.7879945786787 3.1771219566165 0.827884812659923 +221.15 13.7888944250287 3.17712301680713 0.833484439686718 +233.38 13.7897942716803 3.17712407621081 0.815708664635072 +225.19 13.7906941186334 3.17712513482753 0.815461207804963 +233.58 13.7915939658877 3.17712619265729 0.801259276644303 +230.21 13.7924938134431 3.17712724970008 0.815368939728634 +226.15 13.7933936612992 3.17712830595592 0.809120716801662 +225.43 13.7942935094559 3.17712936142479 0.80662422216179 +226.16 13.795193357913 3.1771304161067 0.813608157749629 +221 13.7960932066702 3.17713147000164 0.826933096325355 +225.47 13.7969930557273 3.17713252310962 0.816432473568342 +234.03 13.797892905084 3.17713357543062 0.810715850817643 +224.87 13.7987927547402 3.17713462696466 0.822268687924726 +224.28 13.7996926046957 3.17713567771172 0.821892221841387 +238.42 13.8005924549501 3.17713672767182 0.810641513765856 +233.08 13.7115098868676 3.17612449104245 0.810450481256824 +237.76 13.7124097059724 3.17612561779804 0.802458932521035 +234.05 13.7133095253979 3.17612674376702 0.806086014524777 +235.66 13.7142093451439 3.17612786894937 0.811558727129403 +235.06 13.7151091652102 3.17612899334511 0.821455875519045 +241.7 13.7160089855966 3.17613011695422 0.775861931967168 +229.58 13.7169088063028 3.17613123977671 0.810184409868946 +224.68 13.7178086273286 3.17613236181258 0.804764531905274 +219.67 13.7187084486738 3.17613348306182 0.810698105220806 +223.67 13.7196082703381 3.17613460352443 0.822160660649358 +221.66 13.7205080923214 3.17613572320041 0.818026906186671 +231.38 13.7214079146234 3.17613684208977 0.814737589966948 +225.16 13.7223077372439 3.17613796019249 0.812066845404882 +219.81 13.7232075601826 3.17613907750857 0.826359536322636 +227.59 13.7241073834394 3.17614019403803 0.817998899033807 +232.68 13.7250072070141 3.17614130978084 0.829035868348709 +234.79 13.7259070309063 3.17614242473702 0.834494882466978 +234.84 13.7268068551159 3.17614353890656 0.828806004820117 +237.73 13.7277066796426 3.17614465228947 0.830658735220014 +244.13 13.7286065044862 3.17614576488573 0.833598153007168 +238.08 13.7295063296466 3.17614687669534 0.846346308589821 +231.1 13.7304061551234 3.17614798771832 0.826427763383571 +235.35 13.7313059809165 3.17614909795464 0.827633456230312 +234.98 13.7322058070256 3.17615020740432 0.828438766260986 +228.19 13.7331056334505 3.17615131606736 0.838719949052699 +224.97 13.7340054601909 3.17615242394374 0.824904843563183 +226.3 13.7349052872468 3.17615353103347 0.829752274089809 +226.68 13.7358051146177 3.17615463733655 0.825657201361077 +238.19 13.7367049423036 3.17615574285298 0.80927129527519 +237.87 13.7376047703041 3.17615684758275 0.819251623666806 +240.6 13.7385045986192 3.17615795152586 0.8106897967251 +249.59 13.7394044272484 3.17615905468232 0.793375019941867 +250.34 13.7403042561916 3.17616015705212 0.808262373162906 +248.25 13.7412040854487 3.17616125863526 0.811599902060441 +244.79 13.7421039150193 3.17616235943173 0.793375348452683 +234.86 13.7430037449032 3.17616345944154 0.815904365106768 +220.54 13.7439035751003 3.17616455866469 0.814853581947859 +216.43 13.7448034056102 3.17616565710117 0.821333206933055 +214.36 13.7457032364328 3.17616675475099 0.817505928072718 +239.23 13.7466030675679 3.17616785161413 0.821962771547443 +233.06 13.7475028990151 3.17616894769061 0.812710612341447 +230.9 13.7484027307744 3.17617004298041 0.836681441484069 +231.54 13.7493025628454 3.17617113748355 0.83117433138609 +228.39 13.750202395228 3.1761722312 0.826028385855184 +226.66 13.7511022279219 3.17617332412979 0.812795274790896 +236.51 13.7520020609269 3.17617441627289 0.805193618247204 +238.09 13.7529018942427 3.17617550762932 0.821565503982422 +232.2 13.7538017278693 3.17617659819907 0.829394988796089 +239.54 13.7547015618062 3.17617768798214 0.815173078348529 +248.22 13.7556013960534 3.17617877697852 0.801338005240391 +244.91 13.7565012306105 3.17617986518822 0.806583824884975 +253.63 13.7574010654774 3.17618095261124 0.816772890583268 +250.65 13.7583009006538 3.17618203924757 0.809952774409303 +255.4 13.7592007361395 3.17618312509722 0.808932058718119 +259.36 13.7601005719343 3.17618421016017 0.800843706056976 +259.79 13.7610004080379 3.17618529443644 0.812104850648785 +248.81 13.7619002444502 3.17618637792601 0.820147248284304 +235.65 13.7628000811709 3.17618746062889 0.815979170368768 +236.52 13.7636999181998 3.17618854254507 0.810963490314917 +241.01 13.7645997555366 3.17618962367457 0.820556514636818 +240.9 13.7654995931812 3.17619070401736 0.82049627456424 +242.19 13.7663994311333 3.17619178357346 0.823687363755793 +241.41 13.7672992693927 3.17619286234285 0.818762390472011 +237.34 13.7681991079592 3.17619394032555 0.812507028272073 +241.68 13.7690989468325 3.17619501752154 0.819430565705678 +249.77 13.7699987860124 3.17619609393083 0.820910704389368 +249.65 13.7708986254987 3.17619716955342 0.809473514683686 +251.97 13.7717984652912 3.1761982443893 0.809380538882021 +240.15 13.7726983053896 3.17619931843847 0.824953997534762 +240.05 13.7735981457937 3.17620039170093 0.82309892959316 +232.55 13.7744979865034 3.17620146417668 0.820790265407644 +235.88 13.7753978275183 3.17620253586572 0.818719155693868 +234.7 13.7762976688382 3.17620360676805 0.815778870787499 +234.41 13.777197510463 3.17620467688367 0.817602579654987 +242.69 13.7780973523924 3.17620574621257 0.822734664156439 +244.81 13.7789971946262 3.17620681475475 0.815094641246303 +248.23 13.7798970371641 3.17620788251021 0.816116456872674 +236.2 13.780796880006 3.17620894947896 0.811035624748522 +239.26 13.7816967231515 3.17621001566098 0.806334675797013 +242.93 13.7825965666006 3.17621108105629 0.801755817888639 +239 13.7834964103529 3.17621214566486 0.79598071584154 +238.21 13.7843962544082 3.17621320948672 0.811531671384653 +232.43 13.7852960987663 3.17621427252185 0.822479190852322 +242.22 13.7861959434271 3.17621533477025 0.826473396655826 +243.98 13.7870957883901 3.17621639623192 0.822747942083438 +230.95 13.7879956336554 3.17621745690687 0.832482362661808 +218 13.7888954792225 3.17621851679508 0.839216642116084 +219.41 13.7897953250913 3.17621957589656 0.836723147449661 +225.48 13.7906951712616 3.1762206342113 0.823945021135528 +222.58 13.7915950177332 3.17622169173931 0.817902955939766 +228.86 13.7924948645057 3.17622274848059 0.822831765935214 +225.2 13.7933947115791 3.17622380443512 0.822031386556218 +218.97 13.794294558953 3.17622485960292 0.816828592922195 +228.43 13.7951944066272 3.17622591398398 0.823928639238739 +231.17 13.7960942546016 3.17622696757829 0.82224181425518 +228.27 13.7969941028759 3.17622802038587 0.830192253054266 +235.29 13.7978939514498 3.1762290724067 0.816413023978951 +233.98 13.7987938003232 3.17623012364078 0.817277445291118 +229.1 13.7996936494959 3.17623117408812 0.81885941254352 +239.93 13.8005934989675 3.17623222374871 0.808267564856174 +235.79 13.7115110080559 3.17522001784285 0.808386273092246 +239.35 13.7124108263782 3.17522114427694 0.819454766751758 +230.56 13.7133106450213 3.17522226992464 0.812862286158022 +234.19 13.7142104639849 3.17522339478595 0.810137493905412 +231.03 13.7151102832687 3.17522451886085 0.807143191864915 +241.42 13.7160101028726 3.17522564214937 0.812029752538979 +231.22 13.7169099227963 3.17522676465148 0.811265981193289 +230.05 13.7178097430397 3.17522788636719 0.81195799219587 +215.65 13.7187095636024 3.1752290072965 0.819771521827825 +227.16 13.7196093844843 3.1752301274394 0.828857267738332 +230.09 13.7205092056851 3.17523124679591 0.807192030386797 +222.71 13.7214090272046 3.175232365366 0.819805541636076 +224.42 13.7223088490427 3.17523348314969 0.816037624741879 +226.19 13.7232086711989 3.17523460014697 0.821574245372192 +226.8 13.7241084936733 3.17523571635784 0.806181558482781 +229.78 13.7250083164654 3.1752368317823 0.816397327658115 +227.6 13.7259081395751 3.17523794642035 0.816913334656819 +228.76 13.7268079630022 3.17523906027198 0.810598368977827 +228.01 13.7277077867465 3.17524017333719 0.820597980803634 +229.85 13.7286076108077 3.17524128561599 0.81880121678669 +238.49 13.7295074351855 3.17524239710837 0.81440640511942 +231.03 13.7304072598799 3.17524350781434 0.809532853011114 +225.01 13.7313070848904 3.17524461773388 0.831901898861561 +225.93 13.7322069102171 3.17524572686699 0.819294997805218 +220.07 13.7331067358595 3.17524683521369 0.827350433876331 +223.55 13.7340065618175 3.17524794277396 0.82599028994056 +231.54 13.7349063880908 3.1752490495478 0.813163431852595 +229.04 13.7358062146793 3.17525015553522 0.825343291695537 +238.87 13.7367060415826 3.1752512607362 0.802020899620979 +230.15 13.7376058688007 3.17525236515075 0.803099475915896 +238.34 13.7385056963332 3.17525346877888 0.790189465372484 +236.59 13.7394055241799 3.17525457162057 0.80064635873724 +236.9 13.7403053523407 3.17525567367582 0.801387411294532 +246.35 13.7412051808152 3.17525677494464 0.795365985494502 +247.31 13.7421050096033 3.17525787542702 0.791543368185704 +243.87 13.7430048387048 3.17525897512297 0.804991975378207 +233.56 13.7439046681193 3.17526007403247 0.821642750053545 +223.4 13.7448044978467 3.17526117215553 0.82636139937948 +228.64 13.7457043278868 3.17526226949215 0.835926176442168 +236.85 13.7466041582394 3.17526336604232 0.830706681197083 +243.06 13.7475039889041 3.17526446180605 0.815928768714219 +236.09 13.7484038198809 3.17526555678333 0.832805633324849 +236.32 13.7493036511694 3.17526665097417 0.832585949177877 +231.53 13.7502034827695 3.17526774437855 0.817156761154735 +232.76 13.7511033146808 3.17526883699649 0.803778179120844 +234.42 13.7520031469033 3.17526992882797 0.816405984743883 +228.53 13.7529029794367 3.17527101987299 0.827112337300146 +234.48 13.7538028122807 3.17527211013157 0.81540436162776 +248.39 13.7547026454351 3.17527319960368 0.812168326277503 +247.65 13.7556024788997 3.17527428828934 0.822435014693565 +245.79 13.7565023126743 3.17527537618854 0.813826264936941 +252.71 13.7574021467587 3.17527646330128 0.802866538629487 +257.21 13.7583019811526 3.17527754962756 0.809087266725724 +263.45 13.7592018158557 3.17527863516737 0.796897027616603 +259.81 13.760101650868 3.17527971992072 0.796762227480016 +260.1 13.7610014861891 3.17528080388761 0.803462670729416 +252.14 13.7619013218189 3.17528188706803 0.81297987553544 +230.41 13.7628011577571 3.17528296946198 0.821550250561671 +231.97 13.7637009940034 3.17528405106946 0.820413707455272 +237.54 13.7646008305577 3.17528513189046 0.814560888018283 +243.88 13.7655006674198 3.175286211925 0.804436654007206 +251.31 13.7664005045893 3.17528729117306 0.809321456165068 +253.42 13.7673003420662 3.17528836963465 0.803494892080805 +243.07 13.7682001798501 3.17528944730976 0.813431899334908 +244.21 13.7691000179408 3.1752905241984 0.808317148406261 +241.96 13.7699998563382 3.17529160030055 0.823204898306736 +240.12 13.770899695042 3.17529267561622 0.817612291361971 +233.27 13.7717995340519 3.17529375014542 0.808043586560283 +231.56 13.7726993733678 3.17529482388813 0.827301647525793 +235.64 13.7735992129894 3.17529589684435 0.811381889098755 +230.96 13.7744990529165 3.17529696901409 0.821470369188212 +228.62 13.7753988931488 3.17529804039734 0.810497997997998 +231.78 13.7762987336862 3.17529911099411 0.812022893292516 +233.42 13.7771985745285 3.17530018080438 0.815865848434992 +242.61 13.7780984156753 3.17530124982817 0.816280427833784 +244.81 13.7789982571265 3.17530231806546 0.805091311135248 +240.39 13.7798980988819 3.17530338551626 0.797953258423473 +240.13 13.7807979409412 3.17530445218056 0.804406195406207 +248.41 13.7816977833042 3.17530551805837 0.806385866982018 +233 13.7825976259707 3.17530658314968 0.810276402479435 +232.72 13.7834974689404 3.17530764745449 0.814196698043314 +239.26 13.7843973122132 3.1753087109728 0.813580900661356 +240.72 13.7852971557887 3.17530977370461 0.805999730608632 +241.31 13.7861969996669 3.17531083564992 0.820435948081264 +233.65 13.7870968438474 3.17531189680872 0.820652868036512 +236.47 13.7879966883301 3.17531295718102 0.82004888539824 +230.02 13.7888965331146 3.17531401676681 0.834154903410961 +227.79 13.7897963782009 3.17531507556609 0.825227060199821 +228.63 13.7906962235886 3.17531613357886 0.806733741313142 +234.94 13.7915960692776 3.17531719080513 0.815448124820281 +229.46 13.7924959152676 3.17531824724488 0.8193633393886 +227.28 13.7933957615583 3.17531930289812 0.818759985970929 +218.18 13.7942956081497 3.17532035776484 0.815290320695083 +232.37 13.7951954550413 3.17532141184505 0.813577177205091 +229.84 13.7960953022331 3.17532246513874 0.814639655002539 +230.37 13.7969951497248 3.17532351764591 0.814713557364362 +236.65 13.7978949975162 3.17532456936656 0.807598556227441 +239.92 13.798794845607 3.17532562030069 0.817256348629665 +235.48 13.7996946939971 3.1753266704483 0.816357583668677 +245.08 13.8005945426861 3.17532771980939 0.827093710024223 +229.55 13.7115121289233 3.174315544627 0.807554914924952 +232.92 13.7124119464634 3.17431667073959 0.810792365618917 +232.42 13.7133117643242 3.17431779606601 0.808190942884755 +232.14 13.7142115825055 3.17431892060627 0.820397890256315 +232.62 13.7151114010072 3.17432004436035 0.821618327871533 +229.52 13.7160112198288 3.17432116732826 0.822470141130475 +226.17 13.7169110389703 3.17432228950999 0.820311846676651 +221.66 13.7178108584314 3.17432341090555 0.827923120441583 +221.12 13.7187106782119 3.17432453151493 0.823405645730949 +230.05 13.7196104983115 3.17432565133813 0.808320202206029 +234.43 13.7205103187301 3.17432677037515 0.807655345381244 +219.68 13.7214101394674 3.17432788862599 0.820224289049642 +221.86 13.7223099605232 3.17432900609065 0.823026694452714 +230.08 13.7232097818972 3.17433012276912 0.812149492700886 +232.65 13.7241096035893 3.17433123866141 0.816748753610946 +221.59 13.7250094255992 3.17433235376751 0.817876534418721 +230.9 13.7259092479266 3.17433346808742 0.818496785067732 +226.25 13.7268090705715 3.17433458162115 0.824540109994311 +220.36 13.7277088935335 3.17433569436868 0.816880752702123 +221.71 13.7286087168124 3.17433680633002 0.833754258936088 +240.73 13.729508540408 3.17433791750516 0.813469587432734 +236.93 13.7304083643201 3.17433902789411 0.80325854231945 +226.02 13.7313081885484 3.17434013749687 0.822123482938696 +223.37 13.7322080130927 3.17434124631342 0.829702120540991 +219.44 13.7331078379529 3.17434235434378 0.831026091559392 +218.92 13.7340076631286 3.17434346158793 0.827946757029627 +229.49 13.7349074886197 3.17434456804589 0.813876761163786 +226.94 13.7358073144259 3.17434567371764 0.819740886277866 +230.44 13.736707140547 3.17434677860318 0.815221796190654 +234.29 13.7376069669828 3.17434788270252 0.823327476486483 +228.09 13.738506793733 3.17434898601565 0.817311577799312 +229.15 13.7394066207975 3.17435008854258 0.810801497237241 +238.64 13.740306448176 3.17435119028329 0.794642441544739 +261.02 13.7412062758682 3.17435229123779 0.784551455897658 +248.27 13.742106103874 3.17435339140608 0.812754389558158 +251.49 13.7430059321932 3.17435449078815 0.821889664098221 +252.39 13.7439057608255 3.17435558938401 0.808046218889293 +243.65 13.7448055897706 3.17435668719365 0.810824819711538 +242.23 13.7457054190284 3.17435778421708 0.804557196160347 +245.92 13.7466052485987 3.17435888045428 0.814105835034218 +235.44 13.7475050784812 3.17435997590526 0.816273626264706 +238.93 13.7484049086756 3.17436107057002 0.828869622273331 +232.56 13.7493047391818 3.17436216444856 0.823776070653066 +234.16 13.7502045699996 3.17436325754087 0.811859272604882 +232.33 13.7511044011287 3.17436434984696 0.801120601470842 +234.62 13.7520042325689 3.17436544136681 0.811787808494076 +237.07 13.75290406432 3.17436653210044 0.808369560099813 +241.98 13.7538038963817 3.17436762204784 0.807169200603788 +239.72 13.7547037287538 3.174368711209 0.814004250233455 +246.95 13.7556035614361 3.17436979958394 0.818133754363602 +254.4 13.7565033944284 3.17437088717263 0.807888139647696 +254.17 13.7574032277305 3.1743719739751 0.795011123580021 +266.64 13.7583030613421 3.17437305999132 0.804753837972241 +266.61 13.7592028952629 3.17437414522131 0.788134389184258 +263.72 13.7601027294929 3.17437522966505 0.785769507611101 +245.03 13.7610025640317 3.17437631332256 0.808877658162853 +254.38 13.7619023988792 3.17437739619382 0.81062407465566 +245.56 13.762802234035 3.17437847827884 0.80504236478308 +230.46 13.7637020694991 3.17437955957761 0.812175027312081 +228.59 13.7646019052711 3.17438064009014 0.815808562737704 +236.69 13.7655017413508 3.17438171981642 0.816361512090885 +257.06 13.766401577738 3.17438279875645 0.803738523363938 +252.4 13.7673014144326 3.17438387691023 0.799209231903727 +247.88 13.7682012514342 3.17438495427776 0.814648412509825 +248.19 13.7691010887426 3.17438603085903 0.805179930540161 +243 13.7700009263577 3.17438710665405 0.811003989361702 +250.26 13.7709007642791 3.17438818166281 0.79706618855297 +242.45 13.7718006025067 3.17438925588532 0.816221559188007 +235.67 13.7727004410403 3.17439032932157 0.813994146934742 +234.66 13.7736002798795 3.17439140197156 0.823843600147547 +232.95 13.7745001190243 3.17439247383529 0.828971932244518 +232.79 13.7753999584743 3.17439354491275 0.81914662360449 +237.21 13.7762997982294 3.17439461520395 0.821155233847178 +240.49 13.7771996382893 3.17439568470889 0.818245326743011 +240.7 13.7780994786538 3.17439675342756 0.807471116714954 +235.04 13.7789993193227 3.17439782135996 0.818517490074823 +235.84 13.7798991602957 3.17439888850609 0.803061995466656 +238.31 13.7807990015727 3.17439995486595 0.81072246575758 +234.95 13.7816988431534 3.17440102043954 0.809711767229611 +244.33 13.7825986850375 3.17440208522686 0.813129629143985 +259.01 13.7834985272249 3.1744031492279 0.805165606290868 +251.28 13.7843983697153 3.17440421244267 0.806444983978872 +244.92 13.7852982125086 3.17440527487116 0.815992801528931 +239.59 13.7861980556044 3.17440633651338 0.824577659260124 +235.13 13.7870978990026 3.17440739736931 0.815149345099217 +231.7 13.7879977427029 3.17440845743896 0.824727018649699 +231.6 13.7888975867051 3.17440951672233 0.817503748705344 +233.68 13.789797431009 3.17441057521942 0.815169185608315 +231.85 13.7906972756144 3.17441163293022 0.812176967940649 +236.62 13.791597120521 3.17441268985473 0.806062804853469 +237.94 13.7924969657286 3.17441374599296 0.814257020385861 +232.99 13.793396811237 3.1744148013449 0.810118611512643 +225.92 13.794296657046 3.17441585591055 0.821345950407459 +232.77 13.7951965031553 3.17441690968991 0.830891148325359 +228.78 13.7960963495648 3.17441796268297 0.828188939989117 +230.7 13.7969961962741 3.17441901488974 0.815786774064857 +231.28 13.7978960432831 3.17442006631022 0.813673199213339 +243.75 13.7987958905916 3.1744211169444 0.807641935570091 +253.04 13.7996957381993 3.17442216679228 0.796001393981636 +247.39 13.8005955861059 3.17442321585387 0.810090711228619 +233.24 13.7115132494697 3.1734110713949 0.80518250122776 +241.03 13.7124130662278 3.17341219718599 0.79472794704474 +228.45 13.7133128833066 3.17341332219114 0.808828376363494 +235.45 13.7142127007059 3.17341444641034 0.799023045293724 +235.7 13.7151125184255 3.17341556984359 0.810440290742274 +226 13.7160123364652 3.1734166924909 0.819772581776057 +227.34 13.7169121548247 3.17341781435226 0.828940785509522 +218.9 13.7178119735037 3.17341893542766 0.830190496654639 +222.98 13.7187117925022 3.17342005571711 0.811973566937796 +236.58 13.7196116118198 3.17342117522061 0.80350885444839 +222.98 13.7205114314564 3.17342229393815 0.819550088387875 +226.73 13.7214112514116 3.17342341186974 0.820017535731925 +218.8 13.7223110716854 3.17342452901537 0.821762339349729 +232.99 13.7232108922774 3.17342564537503 0.810220755754576 +241.15 13.7241107131875 3.17342676094874 0.823313500979634 +229.13 13.7250105344153 3.17342787573648 0.82009739225413 +228.16 13.7259103559608 3.17342898973826 0.823442350458813 +233.98 13.7268101778236 3.17343010295407 0.820436316607485 +222.27 13.7277100000036 3.17343121538392 0.830103173029066 +216.95 13.7286098225004 3.1734323270278 0.842996089724587 +223.66 13.729509645314 3.17343343788571 0.839028377740351 +229.38 13.730409468444 3.17343454795765 0.828681990003404 +223.74 13.7313092918903 3.17343565724362 0.826278837985046 +221.33 13.7322091156526 3.17343676574361 0.830078691050498 +224.29 13.7331089397307 3.17343787345763 0.817474711152108 +222.82 13.7340087641244 3.17343898038567 0.822264900206206 +227.58 13.7349085888335 3.17344008652774 0.820211296808482 +232.64 13.7358084138576 3.17344119188383 0.820446174691323 +229.59 13.7367082391967 3.17344229645393 0.829443067502551 +230.64 13.7376080648504 3.17344340023806 0.82134328301901 +235.82 13.7385078908186 3.1734445032362 0.823295966725391 +228.94 13.739407717101 3.17344560544835 0.825764674195494 +231.41 13.7403075436974 3.17344670687453 0.821120140065085 +249.41 13.7412073706077 3.17344780751471 0.799476116285505 +242.2 13.7421071978314 3.17344890736891 0.810403598611608 +243.26 13.7430070253685 3.17345000643711 0.816114371929566 +246.4 13.7439068532187 3.17345110471933 0.807248563546858 +251.29 13.7448066813818 3.17345220221555 0.817142328573157 +244.63 13.7457065098576 3.17345329892578 0.822975614024853 +243.9 13.7466063386458 3.17345439485001 0.814516188252227 +236.59 13.7475061677462 3.17345548998825 0.819257837492003 +245.38 13.7484059971586 3.17345658434048 0.829166218151334 +232.55 13.7493058268827 3.17345767790672 0.821256703870126 +231.92 13.7502056569185 3.17345877068696 0.808564373105848 +232.34 13.7511054872655 3.1734598626812 0.834470762346307 +227.54 13.7520053179236 3.17346095388943 0.825743411933117 +235.51 13.7529051488926 3.17346204431166 0.825793456366705 +246.69 13.7538049801722 3.17346313394788 0.793786515666762 +248.26 13.7547048117623 3.1734642227981 0.806998501447849 +252.13 13.7556046436625 3.17346531086231 0.798106490356402 +249.26 13.7565044758728 3.1734663981405 0.817064944384643 +256.92 13.7574043083927 3.17346748463269 0.789219909795118 +258.76 13.7583041412222 3.17346857033886 0.800103611064494 +262.52 13.759203974361 3.17346965525902 0.805290337096593 +258.17 13.7601038078089 3.17347073939316 0.795718530524041 +254.77 13.7610036415657 3.17347182274129 0.818077819263917 +251.63 13.761903475631 3.17347290530339 0.805394491418878 +240.39 13.7628033100048 3.17347398707948 0.810607538590784 +241.32 13.7637031446868 3.17347506806955 0.801826694908506 +229.48 13.7646029796767 3.1734761482736 0.818173302838944 +231.06 13.7655028149743 3.17347722769162 0.81721586525855 +248.24 13.7664026505795 3.17347830632362 0.799623434558082 +253.37 13.7673024864919 3.17347938416959 0.808164452046777 +251.79 13.7682023227114 3.17348046122953 0.812731907448188 +245.37 13.7691021592378 3.17348153750345 0.8155476616857 +249.28 13.7700019960707 3.17348261299133 0.814163806867189 +242.43 13.7709018332101 3.17348368769319 0.815546289083383 +246.76 13.7718016706556 3.17348476160901 0.812754798309006 +248.47 13.772701508407 3.1734858347388 0.804155476601669 +237.67 13.7736013464642 3.17348690708255 0.824525836009311 +231.17 13.7745011848269 3.17348797864026 0.81773215798898 +245.55 13.7754010234948 3.17348904941194 0.824505895799069 +250.39 13.7763008624678 3.17349011939758 0.807175962323203 +245.9 13.7772007017456 3.17349118859718 0.814791565293941 +240.06 13.778100541328 3.17349225701073 0.817964204987587 +229.6 13.7790003812148 3.17349332463825 0.813720644235218 +241.02 13.7799002214057 3.17349439147971 0.805590856212638 +235.37 13.7808000619005 3.17349545753513 0.807173967573484 +236.86 13.7816999026991 3.17349652280451 0.807650315687227 +247.31 13.7825997438011 3.17349758728784 0.816815791271088 +252.41 13.7834995852064 3.17349865098511 0.801177012744676 +254.35 13.7843994269147 3.17349971389634 0.806869705615642 +239.78 13.7852992689258 3.17350077602151 0.816840707523094 +237.69 13.7861991112395 3.17350183736063 0.821787040499855 +242.15 13.7870989538556 3.17350289791369 0.814188833058083 +248.52 13.7879987967738 3.1735039576807 0.8228974466876 +244.89 13.7888986399939 3.17350501666165 0.817608792582402 +236.59 13.7897984835156 3.17350607485654 0.812309426090293 +236.69 13.7906983273389 3.17350713226537 0.809288143544037 +237.74 13.7915981714634 3.17350818888814 0.810644307007929 +240.23 13.7924980158889 3.17350924472484 0.811502410800386 +231.24 13.7933978606152 3.17351029977548 0.81347682891631 +222.61 13.794297705642 3.17351135404006 0.82456018785849 +229.7 13.7951975509692 3.17351240751857 0.831693903036852 +229.14 13.7960973965965 3.17351346021101 0.822945012356986 +235.42 13.7969972425237 3.17351451211738 0.820598507879273 +244.17 13.7978970887506 3.17351556323768 0.821761748697627 +245.29 13.7987969352769 3.17351661357191 0.817546878558595 +239.5 13.7996967821025 3.17351766312007 0.815226657211615 +238.75 13.800596629227 3.17351871188215 0.812744889590864 +232.65 13.7115143696952 3.17250659814655 0.819949341934415 +231.07 13.7124141856715 3.17250772361614 0.818176295486301 +226.14 13.7133140019685 3.17250884830002 0.817960131604413 +232.45 13.7142138185861 3.17250997219817 0.807209875758887 +230.61 13.7151136355239 3.1725110953106 0.808896893080238 +228.74 13.7160134527817 3.1725122176373 0.810727499295919 +231.08 13.7169132703594 3.17251333917828 0.817686963385484 +226.15 13.7178130882567 3.17251445993353 0.824912339914871 +220.49 13.7187129064734 3.17251557990306 0.815738490120181 +221.55 13.7196127250092 3.17251669908685 0.815572331460674 +224.23 13.720512543864 3.17251781748491 0.811737195134459 +223.13 13.7214123630374 3.17251893509725 0.827635062503086 +217.56 13.7223121825294 3.17252005192384 0.824920704688818 +236.25 13.7232120023396 3.1725211679647 0.819377116179169 +227.16 13.7241118224678 3.17252228321983 0.822476403031571 +238.75 13.7250116429139 3.17252339768921 0.82193695891189 +238.16 13.7259114636775 3.17252451137286 0.825518785165467 +230.65 13.7268112847585 3.17252562427077 0.826421675581404 +227.23 13.7277111061567 3.17252673638293 0.836115823095652 +221.21 13.7286109278718 3.17252784770935 0.83658050829112 +229.67 13.7295107499035 3.17252895825003 0.819448001566808 +239.18 13.7304105722518 3.17253006800496 0.822551977281859 +221.4 13.7313103949162 3.17253117697414 0.821492452707335 +213.59 13.7322102178967 3.17253228515757 0.832051257820031 +222.14 13.733110041193 3.17253339255525 0.815495948784247 +234.85 13.7340098648049 3.17253449916718 0.817961284649178 +243.39 13.7349096887321 3.17253560499336 0.822544396472168 +241.94 13.7358095129744 3.17253671003378 0.823541145710887 +226.19 13.7367093375317 3.17253781428845 0.82418975813279 +231.77 13.7376091624036 3.17253891775736 0.822973461512922 +236.53 13.73850898759 3.17254002044051 0.826101751388598 +236.84 13.7394088130905 3.1725411223379 0.810153092606499 +241.37 13.7403086389051 3.17254222344953 0.807845844463787 +253.77 13.7412084650335 3.1725433237754 0.810246719233722 +251.39 13.7421082914755 3.1725444233155 0.814586676329003 +248.06 13.7430081182307 3.17254552206984 0.812054479186649 +239.53 13.7439079452991 3.17254662003841 0.808915403422983 +245.42 13.7448077726804 3.17254771722122 0.815631113734487 +248.55 13.7457076003743 3.17254881361825 0.805724615372471 +248.09 13.7466074283807 3.17254990922951 0.803499408909314 +245.58 13.7475072566992 3.172551004055 0.81349232444123 +238.83 13.7484070853298 3.17255209809472 0.830080715194518 +236.06 13.7493069142721 3.17255319134867 0.826784466228204 +233.15 13.750206743526 3.17255428381683 0.822518046171381 +236.36 13.7511065730912 3.17255537549922 0.818120860372073 +242.68 13.7520064029674 3.17255646639583 0.822492244773046 +232.26 13.7529062331546 3.17255755650666 0.818418756181279 +245.1 13.7538060636524 3.17255864583171 0.800184859748575 +245.23 13.7547058944606 3.17255973437097 0.808910503747229 +240.22 13.755605725579 3.17256082212446 0.816294573289853 +250.08 13.7565055570073 3.17256190909215 0.820243059905855 +252.94 13.7574053887455 3.17256299527406 0.797599740512488 +265.34 13.7583052207931 3.17256408067018 0.798329206556799 +261.91 13.7592050531501 3.17256516528051 0.808729285688939 +256.46 13.7601048858161 3.17256624910505 0.806019340118069 +253.07 13.761004718791 3.1725673321438 0.806313309249255 +251.63 13.7619045520745 3.17256841439675 0.817808045037683 +240.67 13.7628043856664 3.17256949586391 0.81484379795004 +232.56 13.7637042195665 3.17257057654527 0.807886655328937 +235.07 13.7646040537745 3.17257165644084 0.815751057676126 +238.32 13.7655038882903 3.17257273555061 0.811853535450816 +237.78 13.7664037231136 3.17257381387457 0.815234797992893 +256.5 13.7673035582442 3.17257489141274 0.809601017904208 +264.06 13.7682033936818 3.1725759681651 0.792376804115888 +246.73 13.7691032294263 3.17257704413166 0.803967167741124 +244.03 13.7700030654774 3.17257811931241 0.800481383917881 +245.44 13.7709029018349 3.17257919370735 0.799216845806529 +236.63 13.7718027384985 3.17258026731649 0.817962099581044 +237.16 13.7727025754681 3.17258134013982 0.813731157972336 +242.57 13.7736024127434 3.17258241217733 0.818704394890036 +247.08 13.7745022503242 3.17258348342904 0.814709188025583 +246.7 13.7754020882102 3.17258455389493 0.829111533763622 +250.76 13.7763019264013 3.172585623575 0.816140789942744 +247.01 13.7772017648972 3.17258669246926 0.815128760998882 +230.35 13.7781016036978 3.1725877605777 0.817954249509261 +234.08 13.7790014428026 3.17258882790033 0.817690057924944 +235.62 13.7799012822117 3.17258989443713 0.805737990958175 +240.16 13.7808011219246 3.17259096018811 0.822550380838598 +247.31 13.7817009619413 3.17259202515327 0.820634757637028 +256.36 13.7826008022614 3.1725930893326 0.814210694117173 +257.17 13.7835006428848 3.17259415272611 0.805482871665313 +263.98 13.7844004838113 3.1725952153338 0.80256934349658 +259.94 13.7853003250405 3.17259627715565 0.793412026064034 +257.13 13.7862001665723 3.17259733819168 0.811909200085466 +251.7 13.7871000084064 3.17259839844187 0.80915508995673 +244.34 13.7879998505427 3.17259945790623 0.814540037019759 +234.1 13.7888996929809 3.17260051658476 0.806213480474957 +236.57 13.7897995357208 3.17260157447746 0.820531292550363 +229.38 13.7906993787622 3.17260263158432 0.817755823261808 +236.98 13.7915992221048 3.17260368790534 0.806558150507195 +235.04 13.7924990657483 3.17260474344052 0.803466502765827 +230.09 13.7933989096927 3.17260579818987 0.825829691611053 +224.49 13.7942987539377 3.17260685215337 0.82362869528781 +231 13.795198598483 3.17260790533103 0.826317878191077 +229.73 13.7960984433284 3.17260895772285 0.822147014522937 +239.05 13.7969982884737 3.17261000932882 0.81891300049616 +249.77 13.7978981339186 3.17261106014895 0.82339162477188 +248.9 13.798797979663 3.17261211018322 0.80650444372657 +230.14 13.7996978257067 3.17261315943165 0.816119482160758 +228.74 13.8005976720493 3.17261420789423 0.816261938327741 +233.87 13.7115154895997 3.17160212488196 0.820106891701828 +235.46 13.7124153047945 3.17160325003006 0.817288165299458 +231.88 13.7133151203099 3.17160437439266 0.803903204472542 +227.84 13.7142149361459 3.17160549796976 0.815340384668256 +226.44 13.7151147523022 3.17160662076136 0.811361484419749 +220.11 13.7160145687784 3.17160774276747 0.822618116531113 +225.9 13.7169143855746 3.17160886398807 0.817961912464708 +228.59 13.7178142026903 3.17160998442317 0.811680868507661 +235.19 13.7187140201254 3.17161110407277 0.807405830218738 +226.87 13.7196138378796 3.17161222293686 0.820477153444225 +224.04 13.7205136559528 3.17161334101544 0.829401778053634 +226.39 13.7214134743447 3.17161445830852 0.827521039309843 +229.01 13.7223132930551 3.17161557481608 0.82288983507884 +231.26 13.7232131120837 3.17161669053814 0.828436425801671 +231.96 13.7241129314304 3.17161780547468 0.832493996044862 +235.69 13.7250127510949 3.17161891962571 0.827398822238901 +232.53 13.7259125710769 3.17162003299123 0.81460663582048 +218.82 13.7268123913764 3.17162114557123 0.819474431309866 +229.29 13.7277122119929 3.17162225736571 0.817589403571591 +233.67 13.7286120329264 3.17162336837467 0.831890634668867 +230.67 13.7295118541766 3.17162447859811 0.825662289122325 +229.93 13.7304116757432 3.17162558803603 0.823190131610189 +222.39 13.7313114976261 3.17162669668843 0.832675120986259 +220.38 13.732211319825 3.1716278045553 0.829541503972364 +221.65 13.7331111423397 3.17162891163665 0.823186526097349 +234.31 13.73401096517 3.17163001793247 0.829686639438655 +243.99 13.7349107883156 3.17163112344276 0.821369335307021 +235.73 13.7358106117764 3.17163222816751 0.809521586568012 +237.04 13.736710435552 3.17163333210674 0.800657050921446 +233.26 13.7376102596423 3.17163443526044 0.822597818899138 +236.1 13.7385100840471 3.1716355376286 0.827634248806836 +228.4 13.7394099087661 3.17163663921123 0.837635978756365 +237.37 13.7403097337991 3.17163774000832 0.813186897057028 +244.19 13.7412095591458 3.17163884001987 0.806479737080517 +243.07 13.7421093848062 3.17163993924588 0.809372315964212 +251.86 13.7430092107798 3.17164103768635 0.805621463770761 +247.58 13.7439090370666 3.17164213534128 0.814799326543006 +239.81 13.7448088636663 3.17164323221066 0.822485643849368 +249.03 13.7457086905786 3.1716443282945 0.803761819692091 +244.68 13.7466085178033 3.1716454235928 0.823095630344395 +236.94 13.7475083453403 3.17164651810554 0.824723260366613 +230.38 13.7484081731892 3.17164761183274 0.831322814583912 +237.76 13.7493080013499 3.17164870477439 0.839462768851802 +235.58 13.7502078298222 3.17164979693048 0.827698603582583 +236.06 13.7511076586057 3.17165088830102 0.808068191862632 +239.58 13.7520074877004 3.17165197888601 0.811038186157518 +242.1 13.7529073171059 3.17165306868544 0.808835070767087 +244.14 13.7538071468221 3.17165415769932 0.814889109267941 +237.37 13.7547069768487 3.17165524592763 0.817205895210616 +243.17 13.7556068071854 3.17165633337039 0.816231758299537 +247.96 13.7565066378322 3.17165742002759 0.815932964919828 +248.78 13.7574064687887 3.17165850589922 0.814335354132781 +268.69 13.7583063000547 3.17165959098529 0.796377200002937 +267.69 13.75920613163 3.17166067528579 0.809194117141137 +252.76 13.7601059635144 3.17166175880073 0.827743707032067 +245.29 13.7610057957077 3.1716628415301 0.828872870831894 +242.08 13.7619056282095 3.1716639234739 0.834309974101273 +239.26 13.7628054610198 3.17166500463213 0.810881886549542 +234.75 13.7637052941383 3.17166608500479 0.81540904378524 +238.22 13.7646051275647 3.17166716459187 0.817763630289789 +234 13.7655049612988 3.17166824339338 0.80852214628908 +242.05 13.7664047953405 3.17166932140932 0.80966066185347 +254.85 13.7673046296894 3.17167039863968 0.817488719998627 +243.92 13.7682044643454 3.17167147508446 0.797986701293689 +249.56 13.7691042993082 3.17167255074366 0.805476198355008 +239.8 13.7700041345777 3.17167362561727 0.813690964349462 +248.34 13.7709039701535 3.17167469970531 0.800189167321915 +250.13 13.7718038060355 3.17167577300776 0.805388489917097 +247.74 13.7727036422234 3.17167684552463 0.819688768606225 +246.67 13.7736034787171 3.17167791725591 0.825705668978361 +246.34 13.7745033155162 3.1716789882016 0.804201362322931 +243.82 13.7754031526206 3.17168005836171 0.812080435268237 +246.91 13.77630299003 3.17168112773622 0.824499558460224 +246.51 13.7772028277443 3.17168219632514 0.818075464992299 +254.67 13.7781026657632 3.17168326412847 0.800319798806188 +240.52 13.7790025040864 3.17168433114621 0.814338972028342 +252.51 13.7799023427138 3.17168539737834 0.803304376930216 +248.82 13.7808021816451 3.17168646282489 0.814545698944806 +253.74 13.7817020208801 3.17168752748583 0.804662421722886 +264.84 13.7826018604185 3.17168859136117 0.798116678505728 +264.73 13.7835017002603 3.17168965445092 0.798042049983379 +253.8 13.784401540405 3.17169071675506 0.801313811085137 +261.1 13.7853013808526 3.1716917782736 0.785895580060648 +252.37 13.7862012216027 3.17169283900653 0.802947305862159 +253.37 13.7871010626552 3.17169389895385 0.807673102842404 +248.9 13.7880009040098 3.17169495811557 0.802228047701954 +238.01 13.7889007456663 3.17169601649168 0.817158561910864 +236.55 13.7898005876245 3.17169707408218 0.807982697132225 +231.6 13.7907004298842 3.17169813088707 0.805029946031328 +231.64 13.7916002724451 3.17169918690635 0.817588598998873 +232.19 13.792500115307 3.17170024214001 0.814981469696403 +231.31 13.7933999584697 3.17170129658806 0.819570880996586 +235.42 13.794299801933 3.17170235025049 0.819932449080936 +235.14 13.7951996456966 3.1717034031273 0.815192161849534 +232.02 13.7960994897603 3.1717044552185 0.830027981307333 +236.56 13.7969993341239 3.17170550652407 0.814894430844553 +236.95 13.7978991787872 3.17170655704402 0.804073400300562 +246.25 13.7987990237499 3.17170760677835 0.80054212261856 +241.17 13.7996988690119 3.17170865572705 0.805347763807098 +239.15 13.8005987145728 3.17170970389013 0.806447057162024 +239.42 13.7115166091833 3.17069765160114 0.816571667098483 +230.95 13.7124164235967 3.17069877642774 0.820628677063374 +239.01 13.7133162383309 3.17069990046906 0.788439821465611 +235.05 13.7142160533855 3.17070102372511 0.818515898944312 +228.55 13.7151158687604 3.17070214619589 0.816105494437362 +220.12 13.7160156844553 3.1707032678814 0.818130784223031 +215.71 13.7169155004701 3.17070438878162 0.817978106380031 +220.15 13.7178153168045 3.17070550889657 0.827530163525365 +224.16 13.7187151334582 3.17070662822624 0.813147899257874 +233.02 13.7196149504311 3.17070774677063 0.805859854566059 +224.05 13.720514767723 3.17070886452974 0.82177070220148 +235.97 13.7214145853335 3.17070998150356 0.824931650703409 +232.78 13.7223144032625 3.1707110976921 0.82124058597827 +225.89 13.7232142215098 3.17071221309535 0.832959402102352 +229.29 13.7241140400751 3.17071332771331 0.826921678423387 +236.64 13.7250138589583 3.17071444154599 0.829752643625707 +236.86 13.725913678159 3.17071555459337 0.82493271742753 +227.95 13.726813497677 3.17071666685546 0.832557032849768 +234.94 13.7277133175123 3.17071777833226 0.827016677090576 +240.8 13.7286131376644 3.17071888902377 0.818081113144491 +239.03 13.7295129581332 3.17071999892997 0.824721888445289 +240.16 13.7304127789185 3.17072110805088 0.835085162274384 +216.45 13.73131260002 3.17072221638649 0.824274442855165 +224.38 13.7322124214375 3.17072332393681 0.822397262581754 +225.53 13.7331122431709 3.17072443070182 0.823399015724587 +242.28 13.7340120652198 3.17072553668153 0.813570713898372 +247.08 13.734911887584 3.17072664187593 0.813150268771614 +245.31 13.7358117102634 3.17072774628503 0.805012308936641 +238.06 13.7367115332576 3.17072884990882 0.809920565409777 +235.63 13.7376113565666 3.1707299527473 0.815004638571624 +242.61 13.73851118019 3.17073105480047 0.821116931663601 +236.11 13.7394110041276 3.17073215606833 0.823383952880832 +236.84 13.7403108283792 3.17073325655088 0.826163950021038 +242.16 13.7412106529446 3.17073435624812 0.822111914320155 +239.82 13.7421104778236 3.17073545516004 0.814983807015951 +246.51 13.7430103030158 3.17073655328664 0.82605419565646 +249.86 13.7439101285212 3.17073765062793 0.804066628727871 +242.22 13.7448099543395 3.1707387471839 0.816676558536558 +244.95 13.7457097804704 3.17073984295454 0.819511716422618 +239.53 13.7466096069138 3.17074093793987 0.815655064167667 +239.65 13.7475094336693 3.17074203213987 0.816902974289039 +234.69 13.7484092607369 3.17074312555455 0.815697151424288 +226.67 13.7493090881162 3.1707442181839 0.82980206840454 +228.31 13.7502089158071 3.17074531002792 0.822240794982288 +225.75 13.7511087438092 3.17074640108662 0.819213987580972 +241.61 13.7520085721225 3.17074749135998 0.798248027336196 +248.12 13.7529084007466 3.17074858084802 0.807793371155569 +244.25 13.7538082296814 3.17074966955072 0.803350263566885 +241.68 13.7547080589266 3.17075075746808 0.8048225478063 +249.91 13.7556078884819 3.17075184460012 0.802819926663496 +247.16 13.7565077183473 3.17075293094681 0.811661862506829 +250.22 13.7574075485224 3.17075401650817 0.808771989519888 +256.82 13.758307379007 3.17075510128419 0.804520860433988 +268.92 13.7592072098009 3.17075618527487 0.805407070895255 +261.77 13.7601070409039 3.1707572684802 0.81727216587643 +249.27 13.7610068723157 3.17075835090019 0.820162892765902 +245.44 13.7619067040362 3.17075943253484 0.81836821370513 +232.43 13.7628065360651 3.17076051338414 0.824111717321323 +227.53 13.7637063684021 3.1707615934481 0.822419750770049 +240.21 13.7646062010471 3.1707626727267 0.80724044904708 +243.9 13.7655060339998 3.17076375121996 0.814688172526789 +254.41 13.7664058672601 3.17076482892786 0.82054936825067 +248.23 13.7673057008276 3.17076590585041 0.803521928049423 +242.81 13.7682055347021 3.17076698198761 0.817335261637448 +241.99 13.7691053688835 3.17076805733945 0.819182463558794 +233.56 13.7700052033716 3.17076913190594 0.815435444353701 +241.25 13.770905038166 3.17077020568707 0.809222406452066 +245.99 13.7718048732665 3.17077127868284 0.808814766368723 +240.59 13.772704708673 3.17077235089324 0.819114492620772 +243.96 13.7736045443852 3.17077342231829 0.814306571495989 +244.18 13.774504380403 3.17077449295797 0.807761257385853 +243.69 13.7754042167259 3.17077556281229 0.813595037937736 +244.71 13.7763040533539 3.17077663188124 0.815216619517245 +250.31 13.7772038902868 3.17077770016483 0.809275826768149 +248.82 13.7781037275242 3.17077876766304 0.804879165664961 +250.59 13.779003565066 3.17077983437589 0.803693043770792 +249.58 13.7799034029119 3.17078090030336 0.80452452636498 +259.07 13.7808032410618 3.17078196544547 0.800118317495264 +248.29 13.7817030795153 3.1707830298022 0.805250581870428 +258.83 13.7826029182724 3.17078409337355 0.805254919996736 +253.97 13.7835027573327 3.17078515615953 0.793942316814775 +250.8 13.784402596696 3.17078621816013 0.812291389142507 +249.66 13.7853024363621 3.17078727937535 0.815424196833541 +249.7 13.7862022763308 3.17078833980519 0.811534716500637 +254.1 13.7871021166018 3.17078939944965 0.80722579307485 +255.07 13.788001957175 3.17079045830872 0.812690563569235 +245.77 13.78890179805 3.17079151638241 0.821968942682631 +237.76 13.7898016392268 3.17079257367072 0.805210162035636 +229.74 13.790701480705 3.17079363017364 0.818977640952928 +235.77 13.7916013224845 3.17079468589117 0.815512137359384 +221.08 13.7925011645649 3.17079574082331 0.818857044736663 +240.19 13.7934010069462 3.17079679497006 0.805511946370251 +238.79 13.794300849628 3.17079784833142 0.821892090441597 +236.66 13.7952006926101 3.17079890090739 0.823851845908658 +231.47 13.7961005358924 3.17079995269796 0.830788822275322 +231.35 13.7970003794745 3.17080100370313 0.816459558523436 +233.83 13.7979002233563 3.17080205392291 0.817071691705956 +237.46 13.7988000675376 3.17080310335729 0.81083488228005 +242.19 13.7996999120181 3.17080415200627 0.810746782964518 +244.73 13.8005997567975 3.17080519986984 0.816190415147551 +233.16 13.711517728446 3.16979317830408 0.815781167806418 +225.46 13.7124175420783 3.16979430280918 0.80898006422482 +231.19 13.7133173560313 3.16979542652924 0.815759964924397 +228.79 13.7142171703048 3.16979654946424 0.811458547623946 +225.07 13.7151169848986 3.1697976716142 0.817985592099938 +221.48 13.7160167998124 3.1697987929791 0.816578178505231 +227.01 13.7169166150461 3.16979991355895 0.809053313423036 +217.25 13.7178164305993 3.16980103335375 0.824006100146668 +229.42 13.7187162464719 3.16980215236349 0.81989366160092 +233.77 13.7196160626637 3.16980327058818 0.810518485908812 +228.29 13.7205158791744 3.16980438802781 0.812260307523208 +230.69 13.7214156960038 3.16980550468238 0.82875117267259 +228.36 13.7223155131517 3.16980662055189 0.821791953693794 +225.72 13.7232153306179 3.16980773563633 0.805401444998474 +228.35 13.7241151484021 3.16980884993572 0.823568342259007 +239.93 13.7250149665041 3.16980996345004 0.830796194999223 +231.98 13.7259147849237 3.16981107617929 0.820134748101497 +229.24 13.7268146036606 3.16981218812347 0.83375546379641 +232.49 13.7277144227147 3.16981329928259 0.817340086808366 +240.48 13.7286142420856 3.16981440965664 0.81832497738584 +237.69 13.7295140617733 3.16981551924561 0.826015235282465 +231.31 13.7304138817775 3.16981662804952 0.831836249797108 +219.86 13.7313137020978 3.16981773606834 0.826849603127591 +227.05 13.7322135227342 3.16981884330209 0.825388626432253 +239.27 13.7331133436864 3.16981994975077 0.806977113194859 +234.18 13.7340131649542 3.16982105541437 0.821189643522747 +246.57 13.7349129865373 3.16982216029288 0.806651299117638 +246.8 13.7358128084355 3.16982326438632 0.815786312122062 +239.98 13.7367126306486 3.16982436769467 0.811033145158019 +228.71 13.7376124531764 3.16982547021794 0.821568075045876 +248.14 13.7385122760187 3.16982657195613 0.803142336072767 +232.14 13.7394120991751 3.16982767290922 0.818129960411778 +231.76 13.7403119226456 3.16982877307723 0.823933221485327 +238.33 13.7412117464298 3.16982987246015 0.824930283422947 +236.64 13.7421115705276 3.16983097105798 0.812166718477247 +246.32 13.7430113949387 3.16983206887072 0.819449617062387 +249.57 13.743911219663 3.16983316589837 0.816275741032446 +245.04 13.7448110447001 3.16983426214092 0.812218478116017 +238.5 13.7457108700498 3.16983535759837 0.821389244037809 +236.52 13.746610695712 3.16983645227073 0.81630440551011 +243.09 13.7475105216864 3.16983754615798 0.795833756256002 +228.92 13.7484103479728 3.16983863926014 0.804127688301668 +217.26 13.749310174571 3.1698397315772 0.831979938360229 +222.69 13.7502100014806 3.16984082310915 0.808987867512735 +224.65 13.7511098287016 3.169841913856 0.81587567244471 +237.98 13.7520096562337 3.16984300381774 0.804805845116997 +240.8 13.7529094840767 3.16984409299438 0.816018640646797 +243.57 13.7538093122303 3.16984518138591 0.812316490727751 +246.87 13.7547091406943 3.16984626899233 0.800417956656347 +238.18 13.7556089694685 3.16984735581364 0.805529696883997 +248.95 13.7565087985526 3.16984844184983 0.804183605127486 +249.22 13.7574086279466 3.16984952710092 0.811380483223385 +255.32 13.75830845765 3.16985061156688 0.815069505796657 +263.77 13.7592082876627 3.16985169524774 0.804502968064939 +245.02 13.7601081179845 3.16985277814347 0.822260774419257 +249.46 13.7610079486152 3.16985386025409 0.814989590045178 +243.38 13.7619077795544 3.16985494157958 0.803776828772984 +233.45 13.7628076108021 3.16985602211995 0.822944465263819 +236.95 13.763707442358 3.16985710187521 0.808885089793571 +239.3 13.7646072742218 3.16985818084533 0.823185233822135 +244.37 13.7655071063933 3.16985925903033 0.810155434094877 +259.85 13.7664069388724 3.16986033643021 0.809449946307123 +254.38 13.7673067716587 3.16986141304495 0.792498696359007 +235.03 13.768206604752 3.16986248887457 0.810664287160414 +246.08 13.7691064381523 3.16986356391905 0.81208994622066 +254.92 13.7700062718591 3.16986463817841 0.80225505759759 +244.62 13.7709061058723 3.16986571165263 0.809921176626007 +244.64 13.7718059401916 3.16986678434171 0.80839151429981 +242.98 13.7727057748169 3.16986785624566 0.81356383269596 +248.89 13.7736056097479 3.16986892736447 0.814056700394419 +247.19 13.7745054449844 3.16986999769814 0.817158931082982 +243.94 13.7754052805262 3.16987106724668 0.836967350677659 +239.83 13.776305116373 3.16987213601007 0.825060249829829 +239.76 13.7772049525246 3.16987320398832 0.818557015039025 +245.65 13.7781047889808 3.16987427118142 0.823412094048707 +242.35 13.7790046257414 3.16987533758938 0.814646966789213 +248.36 13.7799044628062 3.16987640321219 0.806171626961467 +247.14 13.7808043001748 3.16987746804986 0.808897603319944 +252.28 13.7817041378471 3.16987853210237 0.795602457029791 +246.8 13.782603975823 3.16987959536974 0.81071149540012 +252.13 13.783503814102 3.16988065785195 0.810186212302732 +252.15 13.7844036526841 3.16988171954901 0.805310956340319 +242.58 13.785303491569 3.16988278046091 0.820763796691153 +247.45 13.7862033307565 3.16988384058766 0.809843314280432 +247.62 13.7871031702463 3.16988489992925 0.816752413005768 +241.41 13.7880030100382 3.16988595848568 0.807551451600282 +239.11 13.7889028501321 3.16988701625696 0.814146042071438 +248.36 13.7898026905276 3.16988807324307 0.811544818913291 +238.7 13.7907025312246 3.16988912944402 0.815234021118475 +224.21 13.7916023722228 3.16989018485981 0.824605859128299 +233.27 13.792502213522 3.16989123949043 0.8283275020502 +243.55 13.793402055122 3.16989229333588 0.816320405509054 +247.7 13.7943018970226 3.16989334639617 0.813787366931041 +245.51 13.7952017392235 3.16989439867129 0.819385531896978 +241.01 13.7961015817245 3.16989545016123 0.819706545359292 +235.27 13.7970014245255 3.16989650086601 0.822646475505551 +233.88 13.797901267626 3.16989755078561 0.815973362097266 +237.82 13.798801111026 3.16989859992004 0.808482718126756 +248.65 13.7997009547253 3.1698996482693 0.815567488890604 +244.82 13.8006007987235 3.16990069583338 0.817587367350174 +234.43 13.7115188473877 3.1688887049908 0.811641119748068 +227.95 13.7124186602391 3.16888982917441 0.811616817346214 +225.57 13.7133184734112 3.16889095257319 0.816982010350209 +229.71 13.7142182869038 3.16889207518714 0.812136991788504 +223.36 13.7151181007167 3.16889319701627 0.814998865263768 +215.98 13.7160179148496 3.16889431806058 0.819584883477794 +229.29 13.7169177293024 3.16889543832006 0.81284484998548 +226.42 13.7178175440748 3.1688965577947 0.833319047414963 +232.22 13.7187173591665 3.16889767648452 0.827661215225236 +231.77 13.7196171745774 3.16889879438951 0.813024404787257 +232.89 13.7205169903072 3.16889991150966 0.811590109834841 +230.35 13.7214168063557 3.16890102784497 0.804377848914718 +224.5 13.7223166227227 3.16890214339546 0.821296083906128 +232.5 13.7232164394079 3.1689032581611 0.829316847896083 +234.98 13.7241162564112 3.1689043721419 0.823255257679557 +242.25 13.7250160737323 3.16890548533787 0.830656761021659 +235.11 13.725915891371 3.16890659774899 0.828873508493505 +226.56 13.726815709327 3.16890770937527 0.827406535711053 +227.77 13.7277155276002 3.1689088202167 0.82839582052858 +234.11 13.7286153461902 3.16890993027329 0.822616641243171 +239.58 13.729515165097 3.16891103954504 0.817352668695997 +245.37 13.7304149843202 3.16891214803193 0.841267031264818 +224.57 13.7313148038597 3.16891325573397 0.834041374214998 +231.29 13.7322146237152 3.16891436265117 0.841629171667862 +232.99 13.7331144438864 3.16891546878351 0.832706300644948 +241.86 13.7340142643733 3.16891657413099 0.819902343543725 +246.35 13.7349140851754 3.16891767869363 0.811269757330043 +253.03 13.7358139062927 3.1689187824714 0.804276121169093 +244.58 13.7367137277249 3.16891988546432 0.824123378615962 +241.63 13.7376135494718 3.16892098767237 0.82637620936431 +247.47 13.7385133715331 3.16892208909557 0.824678216099631 +244.71 13.7394131939086 3.1689231897339 0.816481331467708 +242.65 13.7403130165982 3.16892428958737 0.802689107235203 +247.56 13.7412128396015 3.16892538865598 0.805480477041245 +243.52 13.7421126629183 3.16892648693972 0.810341376283818 +249.96 13.7430124865485 3.16892758443859 0.809601258175262 +250.91 13.7439123104918 3.1689286811526 0.820996077093638 +250.46 13.744812134748 3.16892977708173 0.823489082483515 +242.94 13.7457119593168 3.16893087222599 0.812826762282459 +241.17 13.7466117841981 3.16893196658538 0.812671908634298 +225.85 13.7475116093915 3.16893306015989 0.812163299829649 +222.66 13.748411434897 3.16893415294953 0.828868449643554 +229.29 13.7493112607142 3.16893524495429 0.840327680861364 +229.63 13.7502110868429 3.16893633617418 0.819134153655874 +233.6 13.751110913283 3.16893742660918 0.814747926852428 +239.69 13.7520107400341 3.1689385162593 0.808861535182373 +245.52 13.7529105670961 3.16893960512454 0.822128548909867 +245.64 13.7538103944687 3.1689406932049 0.81066586596022 +244.89 13.7547102221518 3.16894178050037 0.807532673114419 +237.57 13.755610050145 3.16894286701096 0.815798953072189 +242.2 13.7565098784482 3.16894395273665 0.804379424405038 +248.58 13.7574097070612 3.16894503767746 0.815099912144606 +244.9 13.7583095359837 3.16894612183338 0.816850178824585 +247.98 13.7592093652154 3.16894720520441 0.806912456905373 +239.01 13.7601091947563 3.16894828779054 0.814264089059888 +240.3 13.761009024606 3.16894936959178 0.810127731105701 +243.23 13.7619088547643 3.16895045060812 0.809712180092585 +236.86 13.762808685231 3.16895153083957 0.810654834065024 +236.34 13.7637085160059 3.16895261028612 0.813367082504671 +236.53 13.7646083470887 3.16895368894776 0.819860440150295 +244.45 13.7655081784793 3.16895476682451 0.802371731075912 +257.8 13.7664080101774 3.16895584391636 0.791549251979369 +249.49 13.7673078421827 3.1689569202233 0.800608062631998 +240.03 13.7682076744951 3.16895799574533 0.806390629340412 +242.97 13.7691075071144 3.16895907048246 0.813202537247382 +252.91 13.7700073400402 3.16896014443468 0.796633274038011 +251.41 13.7709071732724 3.168961217602 0.802658625825075 +253.64 13.7718070068108 3.1689622899844 0.815530516887246 +249.94 13.7727068406551 3.16896336158189 0.832980717510717 +241.94 13.7736066748052 3.16896443239447 0.831215873569541 +247.36 13.7745065092607 3.16896550242213 0.848226850763628 +241.12 13.7754063440215 3.16896657166488 0.864863802964734 +243.65 13.7763061790873 3.16896764012271 0.865010301377775 +236.55 13.7772060144579 3.16896870779562 0.831721193390517 +241.95 13.7781058501331 3.16896977468361 0.830006298091404 +252 13.7790056861127 3.16897084078668 0.807653654035111 +246.21 13.7799055223965 3.16897190610483 0.81764681534774 +237.71 13.7808053589841 3.16897297063806 0.817889076710086 +246.02 13.7817051958755 3.16897403438636 0.812217822001841 +253.85 13.7826050330703 3.16897509734974 0.819614337600307 +260.41 13.7835048705684 3.16897615952818 0.818713430363916 +259.38 13.7844047083695 3.1689772209217 0.814638956473274 +249.69 13.7853045464733 3.16897828153029 0.813938206089226 +243.07 13.7862043848798 3.16897934135395 0.815319460968073 +248.63 13.7871042235886 3.16898040039267 0.823219025639743 +249.51 13.7880040625996 3.16898145864646 0.820729685515717 +237.88 13.7889039019124 3.16898251611532 0.815477239128936 +242.86 13.789803741527 3.16898357279924 0.808248274690178 +239.62 13.7907035814429 3.16898462869822 0.799463968535905 +230.74 13.7916034216601 3.16898568381226 0.81475534845936 +229.29 13.7925032621784 3.16898673814136 0.825464971516958 +237.67 13.7934031029974 3.16898779168552 0.819858691153363 +242.02 13.7943029441169 3.16898884444474 0.8060978336334 +237.71 13.7952027855368 3.16898989641901 0.817717567040196 +246.97 13.7961026272568 3.16899094760833 0.811012260793068 +245.22 13.7970024692767 3.16899199801271 0.808980512696274 +242.34 13.7979023115963 3.16899304763214 0.820993792833577 +247.81 13.7988021542153 3.16899409646662 0.814953531326043 +253.52 13.7997019971335 3.16899514451616 0.819485245913258 +249.68 13.8006018403507 3.16899619178073 0.814536740634936 +241.22 13.7115199660084 3.1679842316613 0.808924423315866 +232.78 13.7124197780791 3.16798535552341 0.805463549794579 +229.33 13.7133195904706 3.16798647860092 0.811443314855131 +230.92 13.7142194031826 3.16798760089382 0.811328170153739 +227.86 13.7151192162148 3.16798872240213 0.814094668644491 +218.98 13.7160190295671 3.16798984312584 0.817873227261783 +231.79 13.7169188432391 3.16799096306494 0.821922924733092 +225.43 13.7178186572308 3.16799208221944 0.815984126922495 +235.68 13.7187184715419 3.16799320058933 0.816777185926006 +228.84 13.7196182861721 3.16799431817461 0.821940747263333 +237.04 13.7205181011212 3.16799543497529 0.83346963356339 +228.51 13.7214179163891 3.16799655099136 0.818540149858442 +234.07 13.7223177319754 3.16799766622281 0.817325060865468 +243.46 13.7232175478799 3.16799878066965 0.829593869307807 +235.28 13.7241173641025 3.16799989433187 0.82668531552218 +234.57 13.7250171806429 3.16800100720948 0.827426478509103 +227.39 13.7259169975009 3.16800211930248 0.814734134480126 +220.16 13.7268168146763 3.16800323061085 0.828582491883359 +232.71 13.7277166321687 3.16800434113461 0.818152067612665 +236.18 13.7286164499781 3.16800545087374 0.815813603908305 +236.98 13.7295162681042 3.16800655982825 0.817026316988352 +238.7 13.7304160865467 3.16800766799814 0.841919214807813 +228.75 13.7313159053055 3.1680087753834 0.829632210853106 +224.21 13.7322157243803 3.16800988198403 0.828472067220114 +237.75 13.7331155437709 3.16801098780004 0.809866344904399 +250.87 13.734015363477 3.16801209283141 0.806126997814918 +251.1 13.7349151834985 3.16801319707816 0.802876631079478 +249.45 13.7358150038351 3.16801430054027 0.813809210218542 +246.95 13.7367148244866 3.16801540321775 0.811887015232546 +236.71 13.7376146454527 3.1680165051106 0.825194626605254 +244.22 13.7385144667333 3.16801760621881 0.812411586964476 +233.52 13.7394142883282 3.16801870654238 0.809449927794818 +233.94 13.740314110237 3.16801980608131 0.814283518017006 +243.71 13.7412139324596 3.1680209048356 0.805247987964246 +238.08 13.7421137549957 3.16802200280525 0.804663339605661 +245.24 13.7430135778452 3.16802309999026 0.806488314521223 +242.8 13.7439134010078 3.16802419639062 0.806144257519134 +243.17 13.7448132244832 3.16802529200634 0.814756754127678 +243.87 13.7457130482713 3.16802638683741 0.819512499495322 +230.97 13.7466128723719 3.16802748088383 0.814084897915133 +221.14 13.7475126967846 3.1680285741456 0.814091183033896 +222.71 13.7484125215094 3.16802966662272 0.82372821740161 +232.86 13.7493123465458 3.16803075831519 0.845405544147844 +222.3 13.7502121718939 3.168031849223 0.826842222580918 +230.82 13.7511119975532 3.16803293934616 0.822844601726901 +244 13.7520118235236 3.16803402868466 0.828471009038744 +251.24 13.7529116498049 3.16803511723851 0.827223442217952 +242.6 13.7538114763968 3.16803620500769 0.812265170328525 +245.74 13.7547113032991 3.16803729199222 0.818657501039167 +240.79 13.7556111305116 3.16803837819208 0.809040328460151 +248.11 13.7565109580341 3.16803946360728 0.808215152291532 +243.24 13.7574107858663 3.16804054823781 0.81094720343243 +244.42 13.7583106140081 3.16804163208368 0.810425803845093 +238.19 13.7592104424591 3.16804271514489 0.817832268201665 +237.63 13.7601102712192 3.16804379742142 0.816379615520771 +238.94 13.7610101002882 3.16804487891328 0.810984751092739 +241.16 13.7619099296657 3.16804595962047 0.821647742432777 +238.61 13.7628097593517 3.16804703954299 0.814160377937297 +235.2 13.7637095893459 3.16804811868084 0.809909252957381 +231.75 13.764609419648 3.16804919703401 0.812634729825759 +241.9 13.7655092502578 3.1680502746025 0.814344525437172 +247.94 13.7664090811751 3.16805135138631 0.797090262671625 +246.84 13.7673089123997 3.16805242738545 0.812912320270651 +242.87 13.7682087439314 3.16805350259991 0.821791162076233 +245.15 13.7691085757698 3.16805457702968 0.81857699929681 +252.74 13.7700084079149 3.16805565067477 0.807091376262355 +248.45 13.7709082403664 3.16805672353518 0.811128071333976 +252.78 13.771808073124 3.1680577956109 0.821130351605184 +246.51 13.7727079061876 3.16805886690193 0.852338771794692 +238.06 13.7736077395569 3.16805993740827 0.862144266583584 +245.34 13.7745075732316 3.16806100712993 0.869574130336512 +234.94 13.7754074072117 3.16806207606689 0.864343220766783 +244.04 13.7763072414967 3.16806314421916 0.866857981847304 +244.45 13.7772070760866 3.16806421158674 0.864478883501948 +245.31 13.7781069109811 3.16806527816962 0.83834430487267 +243.5 13.7790067461799 3.1680663439678 0.822177290241805 +240.68 13.7799065816829 3.16806740898129 0.833315155894262 +244.78 13.7808064174897 3.16806847321008 0.817877131446936 +237.85 13.7817062536003 3.16806953665417 0.807784531528405 +254.57 13.7826060900144 3.16807059931355 0.831034836370613 +266.7 13.7835059267317 3.16807166118824 0.829943134566542 +252.62 13.784405763752 3.16807272227822 0.838377288260889 +245.32 13.7853056010751 3.16807378258349 0.814723446501903 +252.93 13.7862054387008 3.16807484210406 0.814088941943448 +245.68 13.7871052766289 3.16807590083992 0.80894735062388 +239.77 13.788005114859 3.16807695879107 0.817367547904966 +225.22 13.7889049533911 3.1680780159575 0.816263066027326 +229.94 13.7898047922248 3.16807907233923 0.812398340117271 +233.53 13.79070463136 3.16808012793624 0.807485306280641 +235.27 13.7916044707965 3.16808118274854 0.817426980927392 +233.12 13.7925043105339 3.16808223677612 0.820955655828128 +236.43 13.7934041505721 3.16808329001899 0.811136936268287 +232.43 13.7943039909109 3.16808434247713 0.807283793860975 +233.13 13.79520383155 3.16808539415056 0.805863890985658 +234.25 13.7961036724892 3.16808644503926 0.810140768943398 +237.36 13.7970035137283 3.16808749514324 0.809709547734812 +236.32 13.7979033552671 3.1680885444625 0.812680148994676 +240.48 13.7988031971053 3.16808959299703 0.815514925373134 +247.69 13.7997030392427 3.16809064074684 0.799731480846843 +241.56 13.8006028816791 3.16809168771192 0.808873693856022 +240.97 13.7115210843082 3.16707975831558 0.812790544977019 +233.04 13.7124208955985 3.16708088185619 0.81692789968652 +227.3 13.7133207072095 3.16708200461243 0.81337377112789 +224.51 13.714220519141 3.16708312658429 0.805389258821333 +226.65 13.7151203313928 3.16708424777178 0.813526459403642 +230.55 13.7160201439646 3.16708536817488 0.819047475326714 +229.89 13.7169199568563 3.16708648779361 0.824204591220298 +231.75 13.7178197700675 3.16708760662796 0.814476188987089 +230.32 13.7187195835981 3.16708872467793 0.806725015106918 +228.79 13.7196193974479 3.16708984194351 0.8248301130377 +230.94 13.7205192116166 3.16709095842471 0.825000274053693 +232.55 13.721419026104 3.16709207412153 0.821511308051303 +232.71 13.7223188409098 3.16709318903395 0.827765837572406 +240.57 13.7232186560339 3.16709430316199 0.827896313356039 +231.54 13.7241184714761 3.16709541650564 0.826350520962853 +235.3 13.725018287236 3.16709652906489 0.822720540010759 +231.26 13.7259181033135 3.16709764083976 0.829906608938348 +222.31 13.7268179197084 3.16709875183022 0.823114483115854 +238.18 13.7277177364204 3.1670998620363 0.818970189701897 +239.13 13.7286175534493 3.16710097145798 0.822895003757945 +236.85 13.7295173707949 3.16710208009526 0.836485121806134 +242.76 13.730417188457 3.16710318794813 0.824521101189373 +234.88 13.7313170064353 3.16710429501661 0.827806131528184 +226.75 13.7322168247296 3.16710540130069 0.828138559444605 +238.27 13.7331166433397 3.16710650680036 0.832428037523657 +248.84 13.7340164622654 3.16710761151563 0.829648334886874 +240.3 13.7349162815064 3.16710871544649 0.817125301540515 +243.47 13.7358161010625 3.16710981859294 0.818957886805703 +239.45 13.7367159209335 3.16711092095499 0.82429056772149 +226.84 13.7376157411192 3.16711202253262 0.824450297192822 +234.19 13.7385155616193 3.16711312332584 0.825625529449299 +233.27 13.7394153824337 3.16711422333465 0.809171638850301 +236.83 13.740315203562 3.16711532255905 0.8084091413357 +237.15 13.7412150250041 3.16711642099902 0.809727072319007 +235.59 13.7421148467598 3.16711751865459 0.814570270880451 +242.82 13.7430146688288 3.16711861552573 0.808887609478329 +230.42 13.7439144912109 3.16711971161245 0.822830557211356 +227.68 13.7448143139058 3.16712080691475 0.822797990469169 +231.63 13.7457141369135 3.16712190143263 0.815938283510125 +224.16 13.7466139602335 3.16712299516608 0.822384287395574 +221.14 13.7475137838658 3.16712408811511 0.816359127565267 +233.79 13.74841360781 3.16712518027972 0.822259419184251 +236.26 13.749313432066 3.16712627165989 0.841702093660427 +224.64 13.7502132566335 3.16712736225564 0.826289359032976 +231.59 13.7511130815123 3.16712845206695 0.83316950962893 +241.45 13.7520129067022 3.16712954109383 0.834278220518511 +244.54 13.752912732203 3.16713062933628 0.822565810913568 +247.1 13.7538125580144 3.16713171679429 0.811582890456645 +235.48 13.7547123841362 3.16713280346787 0.823053911733389 +242.57 13.7556122105683 3.16713388935701 0.798702416729276 +250.9 13.7565120373102 3.16713497446171 0.787274130662814 +253.82 13.7574118643619 3.16713605878198 0.785874904312325 +244.89 13.7583116917232 3.1671371423178 0.802583686494867 +239 13.7592115193937 3.16713822506917 0.809806498036823 +243.57 13.7601113473733 3.16713930703611 0.819451353193684 +244.1 13.7610111756617 3.16714038821859 0.820466733563429 +240.54 13.7619110042588 3.16714146861663 0.81414030728391 +233.57 13.7628108331643 3.16714254823023 0.82016842024862 +232.78 13.7637106623779 3.16714362705937 0.803463464469343 +234.02 13.7646104918995 3.16714470510406 0.813747245922779 +238.36 13.7655103217288 3.1671457823643 0.813252468773955 +240.76 13.7664101518656 3.16714685884009 0.815915121365728 +238.18 13.7673099823096 3.16714793453142 0.817479117317043 +237.79 13.7682098130608 3.1671490094383 0.814290744330559 +241.57 13.7691096441187 3.16715008356071 0.806847223087951 +256 13.7700094754833 3.16715115689867 0.810805140850641 +264.38 13.7709093071542 3.16715222945217 0.809277106818761 +274.56 13.7718091391313 3.16715330122121 0.807605972444395 +250.5 13.7727089714144 3.16715437220579 0.851631822801546 +247.07 13.7736088040031 3.1671554424059 0.854454807686727 +235.56 13.7745086368973 3.16715651182154 0.865779924111763 +239.04 13.7754084700968 3.16715758045272 0.869456237888333 +246.08 13.7763083036014 3.16715864829943 0.870623132527507 +252.11 13.7772081374107 3.16715971536168 0.86815165226206 +254.74 13.7781079715246 3.16716078163945 0.868599633073427 +245.78 13.7790078059429 3.16716184713275 0.871218806208694 +246.23 13.7799076406653 3.16716291184157 0.863598931110402 +241.59 13.7808074756917 3.16716397576592 0.824897400820793 +241.51 13.7817073110217 3.1671650389058 0.820766437485023 +259.03 13.7826071466552 3.1671661012612 0.802879728763886 +262.21 13.783506982592 3.16716716283212 0.819593596827532 +249.22 13.7844068188318 3.16716822361856 0.832836570552431 +241.39 13.7853066553743 3.16716928362052 0.808187488598299 +256.44 13.7862064922195 3.16717034283799 0.806558844211468 +248 13.787106329367 3.16717140127099 0.819413706910752 +231.28 13.7880061668166 3.16717245891949 0.81977684440773 +232.23 13.7889060045681 3.16717351578351 0.812676947410043 +230.8 13.7898058426213 3.16717457186305 0.821603915662651 +232.54 13.7907056809759 3.16717562715809 0.82387548130068 +238.47 13.7916055196318 3.16717668166865 0.812949586659809 +229.23 13.7925053585887 3.16717773539471 0.81578719689164 +231.16 13.7934051978463 3.16717878833628 0.807068320223294 +234.96 13.7943050374045 3.16717984049336 0.805148196523661 +229.39 13.7952048772631 3.16718089186594 0.809160492615671 +227.88 13.7961047174217 3.16718194245402 0.8164428800781 +243.95 13.7970045578803 3.1671829922576 0.812070242841879 +242.2 13.7979043986385 3.16718404127669 0.802738918453841 +248.27 13.7988042396961 3.16718508951128 0.805405039284747 +256.57 13.799704081053 3.16718613696136 0.801000872252036 +258.61 13.8006039227088 3.16718718362694 0.8009657127669 +237.19 13.7115222022871 3.16617528495365 0.817054918348597 +237.7 13.7124220127972 3.16617640817276 0.816664822734539 +233.92 13.713321823628 3.16617753060773 0.811034514737932 +232.67 13.7142216347793 3.16617865225854 0.805617973059501 +229.69 13.7151214462508 3.16617977312521 0.826213930781972 +229.63 13.7160212580424 3.16618089320772 0.821531764794176 +218.54 13.7169210701538 3.16618201250607 0.818385109155553 +221.81 13.7178208825849 3.16618313102027 0.819216252663161 +223.84 13.7187206953352 3.16618424875032 0.820927335109544 +234.45 13.7196205084048 3.1661853656962 0.823557452550676 +233.17 13.7205203217932 3.16618648185792 0.819223053618191 +242.28 13.7214201355004 3.16618759723549 0.819917889375855 +242.68 13.722319949526 3.16618871182889 0.842022900763359 +243.06 13.7232197638699 3.16618982563812 0.83706063925122 +238.61 13.7241195785318 3.16619093866319 0.834532522420369 +239.82 13.7250193935115 3.1661920509041 0.834095178567136 +221.48 13.7259192088088 3.16619316236083 0.84151188255333 +229.47 13.7268190244234 3.16619427303339 0.818716905752157 +242.22 13.7277188403552 3.16619538292179 0.815949017493852 +239.71 13.7286186566039 3.16619649202601 0.821886374426333 +231.56 13.7295184731692 3.16619760034606 0.825504447418427 +230.08 13.730418290051 3.16619870788193 0.840748927492092 +231.6 13.7313181072491 3.16619981463363 0.833660420135322 +237.85 13.7322179247632 3.16620092060115 0.813624316653788 +240.49 13.733117742593 3.16620202578449 0.823109738696483 +244.51 13.7340175607384 3.16620313018365 0.819087879988844 +243.25 13.7349173791992 3.16620423379862 0.820373675201224 +246.52 13.7358171979751 3.16620533662942 0.801275190709325 +231.82 13.7367170170658 3.16620643867603 0.818582937283256 +233.29 13.7376168364712 3.16620753993845 0.814170855454449 +235.66 13.7385166561911 3.16620864041668 0.799306120280658 +233.16 13.7394164762252 3.16620974011073 0.813789822565236 +228.75 13.7403162965733 3.16621083902059 0.806086312143556 +241.87 13.7412161172351 3.16621193714625 0.800010480363427 +246.19 13.7421159382105 3.16621303448772 0.818800796496624 +238.18 13.7430157594993 3.166214131045 0.813696041300156 +232.44 13.7439155811011 3.16621522681808 0.821380355524468 +224.56 13.7448154030158 3.16621632180697 0.82839084424761 +228.48 13.7457152252431 3.16621741601166 0.831562164124392 +233.98 13.7466150477829 3.16621850943215 0.829175042371211 +227.06 13.7475148706349 3.16621960206843 0.823466465480076 +227.97 13.7484146937989 3.16622069392052 0.821257531283794 +242.03 13.7493145172746 3.1662217849884 0.837700417379225 +232.78 13.7502143410618 3.16622287527208 0.827782987663475 +235.51 13.7511141651604 3.16622396477155 0.816003613116235 +239.46 13.75201398957 3.16622505348681 0.812398292625444 +254.06 13.7529138142905 3.16622614141786 0.833686876052342 +243.7 13.7538136393216 3.16622722856471 0.821901106670322 +236.17 13.7547134646632 3.16622831492734 0.81933173874125 +244.27 13.7556132903149 3.16622940050576 0.817364651793345 +242.73 13.7565131162766 3.16623048529996 0.807228345151705 +243.63 13.757412942548 3.16623156930995 0.807727167503051 +235.55 13.758312769129 3.16623265253572 0.820677140757075 +242.96 13.7592125960192 3.16623373497728 0.807874811861622 +239.81 13.7601124232185 3.16623481663461 0.818598383766707 +235.31 13.7610122507267 3.16623589750772 0.817273827230901 +239.59 13.7619120785435 3.16623697759661 0.81926618672428 +237.3 13.7628119066686 3.16623805690128 0.8200316058667 +243.75 13.7637117351019 3.16623913542172 0.815245449035936 +242.14 13.7646115638432 3.16624021315794 0.808424762234655 +231.96 13.7655113928922 3.16624129010992 0.826349981349003 +237.55 13.7664112222487 3.16624236627768 0.810882243552714 +240.19 13.7673110519125 3.16624344166121 0.795895292693856 +232.63 13.7682108818834 3.16624451626051 0.809573322440492 +252.85 13.769110712161 3.16624559007557 0.798359215862159 +253.41 13.7700105427453 3.1662466631064 0.803371257856359 +263.1 13.7709103736359 3.16624773535299 0.800392239265952 +258.73 13.7718102048327 3.16624880681535 0.805637945215722 +267.99 13.7727100363354 3.16624987749347 0.815718896890562 +246.93 13.7736098681439 3.16625094738735 0.821854925189352 +242.94 13.7745097002578 3.16625201649699 0.848130049236799 +242.77 13.775409532677 3.16625308482238 0.852989517845089 +251.22 13.7763093654012 3.16625415236353 0.851585121610804 +253.79 13.7772091984302 3.16625521912044 0.867671856370111 +252.88 13.7781090317638 3.1662562850931 0.860472817283467 +246.72 13.7790088654018 3.16625735028152 0.865034720875199 +244.28 13.7799086993439 3.16625841468568 0.852768490954889 +241.48 13.7808085335899 3.1662594783056 0.825553145336226 +247.2 13.7817083681396 3.16626054114126 0.812184427318629 +254.99 13.7826082029928 3.16626160319267 0.815143003346378 +258.03 13.7835080381493 3.16626266445983 0.820731937766393 +242.01 13.7844078736087 3.16626372494273 0.823813346099439 +252.28 13.785307709371 3.16626478464137 0.821049239229561 +250.85 13.7862075454358 3.16626584355576 0.815930507874777 +254.04 13.7871073818029 3.16626690168589 0.810218598131189 +237.53 13.7880072184722 3.16626795903175 0.814620485913434 +233.76 13.7889070554434 3.16626901559336 0.809562629604419 +225.95 13.7898068927163 3.1662700713707 0.81547588484128 +232.44 13.7907067302906 3.16627112636378 0.822734075182622 +232.61 13.7916065681661 3.16627218057259 0.821354430093078 +224.64 13.7925064063427 3.16627323399713 0.815448726280218 +232.3 13.79340624482 3.16627428663741 0.814652367291141 +227.21 13.7943060835979 3.16627533849341 0.814295558958652 +235.82 13.7952059226761 3.16627638956515 0.814144065436427 +234.17 13.7961057620544 3.16627743985261 0.813066897811349 +244.65 13.7970056017326 3.1662784893558 0.814146007638138 +252.02 13.7979054417104 3.16627953807472 0.799282161363662 +253.24 13.7988052819877 3.16628058600936 0.807359426177014 +265.17 13.7997051225642 3.16628163315972 0.806674855966366 +250.89 13.8006049634397 3.1662826795258 0.805912775556615 +229.14 13.711523319945 3.16527081157551 0.821617060334426 +231.52 13.7124231296751 3.16527193447313 0.824873491342585 +232.43 13.7133229397259 3.16527305658682 0.813894989480486 +223.83 13.7142227500972 3.16527417791659 0.816763872948974 +227.87 13.7151225607888 3.16527529846244 0.829257366786002 +229.7 13.7160223718004 3.16527641822435 0.8085457289863 +222.7 13.7169221831318 3.16527753720233 0.820958003276172 +224.53 13.7178219947828 3.16527865539638 0.81549651415776 +226.29 13.7187218067532 3.1652797728065 0.819220206152397 +236.76 13.7196216190427 3.16528088943269 0.834604889836146 +237.04 13.7205214316512 3.16528200527494 0.825261069528362 +243.85 13.7214212445783 3.16528312033325 0.815695833683562 +232.48 13.7223210578239 3.16528423460762 0.81970943198956 +233.08 13.7232208713878 3.16528534809806 0.823237826307147 +233.17 13.7241206852697 3.16528646080455 0.826837279270863 +239.55 13.7250204994694 3.1652875727271 0.817983173291316 +229.28 13.7259203139867 3.16528868386571 0.830762107733469 +227.03 13.7268201288213 3.16528979422037 0.83519509125236 +240.14 13.727719943973 3.16529090379108 0.82211186947695 +227.6 13.7286197594417 3.16529201257785 0.824361444795211 +232.68 13.729519575227 3.16529312058067 0.827362498773365 +235.77 13.7304193913288 3.16529422779953 0.829570833155521 +233.04 13.7313192077469 3.16529533423445 0.830648509799782 +240.47 13.7322190244809 3.16529643988541 0.815832716506292 +244.64 13.7331188415307 3.16529754475242 0.811141227941921 +245.53 13.7340186588961 3.16529864883547 0.812555095698427 +243.64 13.7349184765769 3.16529975213456 0.82060155332015 +244.65 13.7358182945727 3.16530085464969 0.812886415827592 +225.13 13.7367181128834 3.16530195638087 0.817298786233781 +249.94 13.7376179315088 3.16530305732808 0.812062009698652 +230.42 13.7385177504487 3.16530415749133 0.815222659198347 +221.69 13.7394175697027 3.16530525687062 0.817702120036318 +230.77 13.7403173892708 3.16530635546594 0.81694963170046 +249.79 13.7412172091526 3.16530745327729 0.81018311413319 +240.63 13.742117029348 3.16530855030467 0.820071158713274 +232.86 13.7430168498567 3.16530964654809 0.821122818570958 +239.58 13.7439166706784 3.16531074200753 0.816697934785086 +228 13.7448164918131 3.165311836683 0.826492641762245 +224.35 13.7457163132604 3.1653129305745 0.83167155857756 +230.97 13.7466161350201 3.16531402368202 0.824900751149573 +228.87 13.7475159570921 3.16531511600557 0.822701284237105 +233.03 13.748415779476 3.16531620754514 0.808605814058707 +240.45 13.7493156021717 3.16531729830073 0.840708311424494 +232.88 13.7502154251789 3.16531838827233 0.815243706564917 +239.21 13.7511152484974 3.16531947745996 0.803495770872171 +238.34 13.7520150721269 3.16532056586361 0.816868566228744 +252.24 13.7529148960674 3.16532165348326 0.807125512697037 +241.28 13.7538147203185 3.16532274031894 0.826183192557868 +237.64 13.7547145448799 3.16532382637062 0.824993390449378 +233.43 13.7556143697516 3.16532491163832 0.813309971429022 +246.9 13.7565141949333 3.16532599612203 0.798984353886924 +240.48 13.7574140204246 3.16532707982175 0.816870349987329 +241.8 13.7583138462255 3.16532816273747 0.812401859897858 +245.91 13.7592136723357 3.1653292448692 0.808307466644936 +237.67 13.7601134987549 3.16533032621693 0.823323881278197 +243.26 13.761013325483 3.16533140678067 0.818906129635743 +240.93 13.7619131525197 3.16533248656041 0.819907487734557 +236.4 13.7628129798648 3.16533356555615 0.812922333502202 +235.07 13.7637128075181 3.16533464376789 0.825611104332361 +234.49 13.7646126354793 3.16533572119563 0.810908723009335 +236.76 13.7655124637482 3.16533679783937 0.816803585907262 +233.39 13.7664122923246 3.1653378736991 0.807656015097719 +242.52 13.7673121212084 3.16533894877482 0.807404543257612 +233.69 13.7682119503991 3.16534002306654 0.838124511162644 +242.23 13.7691117798967 3.16534109657425 0.81696823482107 +255.1 13.7700116097009 3.16534216929795 0.795345759181203 +252.48 13.7709114398114 3.16534324123764 0.807173848482873 +252.58 13.7718112702281 3.16534431239331 0.818687320703608 +257.59 13.7727111009508 3.16534538276498 0.813669889727662 +254.08 13.7736109319791 3.16534645235262 0.814226293244561 +255.12 13.774510763313 3.16534752115625 0.823514528588938 +255.63 13.7754105949521 3.16534858917587 0.832403425161765 +261.72 13.7763104268962 3.16534965641146 0.81820662845884 +255.19 13.7772102591451 3.16535072286303 0.860427516346698 +249.09 13.7781100916986 3.16535178853059 0.864649733760483 +246.72 13.7790099245565 3.16535285341412 0.855189986641794 +250.38 13.7799097577185 3.16535391751362 0.84851289309888 +264.06 13.7808095911845 3.1653549808291 0.839380150787216 +253.06 13.7817094249541 3.16535604336055 0.816471120889383 +245.09 13.7826092590272 3.16535710510797 0.807314362195155 +245.24 13.7835090934035 3.16535816607137 0.821155967109645 +247.32 13.7844089280829 3.16535922625073 0.819522625125453 +250.9 13.785308763065 3.16536028564606 0.823040758386748 +245.85 13.7862085983497 3.16536134425736 0.809965105838047 +246.88 13.7871084339368 3.16536240208462 0.818589462755912 +237.28 13.788008269826 3.16536345912785 0.816699208432948 +235.03 13.788908106017 3.16536451538704 0.817737222855893 +228.42 13.7898079425098 3.16536557086219 0.822178287784765 +241.21 13.790707779304 3.1653666255533 0.811937579155526 +230.17 13.7916076163994 3.16536767946037 0.816926295104829 +236.32 13.7925074537959 3.16536873258339 0.806975164491533 +230.4 13.7934072914931 3.16536978492238 0.814004668746905 +242.24 13.7943071294908 3.16537083647731 0.80864355554197 +243.08 13.7952069677889 3.16537188724821 0.813963645893238 +256.73 13.7961068063871 3.16537293723505 0.827190425337451 +273.38 13.7970066452852 3.16537398643784 0.809521047985412 +283.89 13.7979064844829 3.16537503485659 0.809922363549258 +279.77 13.7988063239801 3.16537608249128 0.810356215332329 +263.27 13.7997061637765 3.16537712934192 0.809962632322174 +260.12 13.8006060038719 3.1653781754085 0.804215548227595 +233.26 13.711524437282 3.16436633818117 0.813548005570287 +234.56 13.7124242462323 3.16436746075729 0.809113739532747 +228.03 13.7133240555034 3.16436858254972 0.818762554171129 +225.08 13.7142238650949 3.16436970355844 0.826396978098658 +223.7 13.7151236750067 3.16437082378346 0.822990646195561 +230.5 13.7160234852385 3.16437194322478 0.814461995430909 +226.71 13.7169232957902 3.16437306188239 0.818311463847531 +220.22 13.7178231066614 3.16437417975629 0.823594643009468 +229.03 13.718722917852 3.16437529684649 0.828155103788338 +235.57 13.7196227293617 3.16437641315297 0.824613053671637 +236.23 13.7205225411904 3.16437752867575 0.824881172455793 +235.95 13.7214223533378 3.16437864341481 0.816269053593498 +236.5 13.7223221658036 3.16437975737016 0.826960984408416 +235.36 13.7232219785877 3.16438087054179 0.82557418200704 +231.93 13.7241217916898 3.16438198292971 0.824468561533409 +230.44 13.7250216051097 3.16438309453391 0.825388303544132 +221.89 13.7259214188472 3.16438420535439 0.823338071392721 +229.4 13.726821232902 3.16438531539114 0.826134707893716 +230.11 13.727721047274 3.16438642464418 0.832546039570069 +231.75 13.7286208619629 3.16438753311349 0.834659701628404 +231.31 13.7295206769684 3.16438864079908 0.828255266454521 +246.25 13.7304204922904 3.16438974770094 0.824416599449281 +243.24 13.7313203079286 3.16439085381908 0.813491860999133 +236.35 13.7322201238829 3.16439195915348 0.828572659205605 +244.94 13.7331199401529 3.16439306370415 0.812998400644216 +244.86 13.7340197567385 3.1643941674711 0.815492303266778 +243.5 13.7349195736394 3.16439527045431 0.825066525508598 +232.9 13.7358193908555 3.16439637265378 0.816098784487749 +234.95 13.7367192083864 3.16439747406952 0.816297597583715 +240.06 13.737619026232 3.16439857470153 0.813248050738526 +234.78 13.738518844392 3.16439967454979 0.820125762411013 +240.8 13.7394186628663 3.16440077361432 0.819738943859405 +243.46 13.7403184816545 3.1644018718951 0.805609408296348 +253.44 13.7412183007565 3.16440296939214 0.81564311160738 +245.83 13.7421181201721 3.16440406610544 0.817432960089756 +235.55 13.7430179399009 3.16440516203499 0.837075035067866 +231.04 13.7439177599429 3.16440625718079 0.834839233160052 +239.7 13.7448175802977 3.16440735154285 0.815315015141755 +233.71 13.7457174009652 3.16440844512116 0.825947789394585 +222.43 13.7466172219452 3.16440953791571 0.818378596449034 +235.9 13.7475170432373 3.16441062992652 0.827000105120835 +230.8 13.7484168648414 3.16441172115357 0.824935695435768 +244.46 13.7493166867572 3.16441281159687 0.848533739440334 +242.36 13.7502165089846 3.16441390125641 0.809054643784638 +233.73 13.7511163315232 3.16441499013219 0.8241389439671 +236 13.752016154373 3.16441607822422 0.812079823962364 +231.86 13.7529159775336 3.16441716553248 0.813901450545324 +236.99 13.7538158010049 3.16441825205699 0.815437519472876 +238.91 13.7547156247865 3.16441933779773 0.808476778302986 +234.48 13.7556154488784 3.16442042275471 0.808751440306088 +251.64 13.7565152732802 3.16442150692792 0.810179594563346 +249.35 13.7574150979917 3.16442259031736 0.819220487444189 +238.71 13.7583149230127 3.16442367292304 0.815099826504231 +237.28 13.7592147483431 3.16442475474495 0.825735632061052 +252.48 13.7601145739825 3.16442583578308 0.79950445172509 +242.25 13.7610143999307 3.16442691603745 0.814933051256977 +238.84 13.7619142261876 3.16442799550804 0.808458873761379 +234.15 13.7628140527528 3.16442907419485 0.80846918391003 +233.86 13.7637138796262 3.16443015209789 0.808217059311962 +243.92 13.7646137068076 3.16443122921716 0.80227481082089 +243.3 13.7655135342967 3.16443230555264 0.805467390191461 +228.6 13.7664133620933 3.16443338110434 0.8139827705745 +229.55 13.7673131901971 3.16443445587227 0.823835278418685 +238.08 13.768213018608 3.16443552985641 0.828054487424642 +244.15 13.7691128473258 3.16443660305676 0.817366783214293 +248.48 13.7700126763501 3.16443767547333 0.796589137667615 +259.26 13.7709125056808 3.16443874710612 0.79863394511867 +261.89 13.7718123353177 3.16443981795511 0.799736486105631 +265.04 13.7727121652604 3.16444088802032 0.816937338908488 +261.21 13.7736119955089 3.16444195730173 0.814063823397413 +263.4 13.7745118260629 3.16444302579936 0.818314802059759 +260.46 13.7754116569221 3.16444409351319 0.814132278901381 +248.44 13.7763114880864 3.16444516044322 0.825695999674743 +260.39 13.7772113195555 3.16444622658946 0.836928494487487 +260.23 13.7781111513291 3.16444729195191 0.835861633585235 +259.48 13.7790109834071 3.16444835653055 0.842290673069218 +255.72 13.7799108157893 3.1644494203254 0.827656091152744 +255.52 13.7808106484753 3.16445048333644 0.822762926420784 +242.33 13.7817104814651 3.16445154556368 0.82864011232529 +250.42 13.7826103147583 3.16445260700712 0.805443927095548 +240.24 13.7835101483548 3.16445366766675 0.821094853740479 +246.91 13.7844099822542 3.16445472754257 0.828663251277255 +246.5 13.7853098164565 3.16445578663459 0.819864145401138 +247.37 13.7862096509613 3.1644568449428 0.814971813779603 +244.49 13.7871094857685 3.1644579024672 0.808135213329216 +238.79 13.7880093208778 3.16445895920778 0.811733118539401 +231.85 13.788909156289 3.16446001516456 0.817155866087041 +236.55 13.7898089920019 3.16446107033752 0.823276970379572 +229.15 13.7907088280162 3.16446212472666 0.813017826757629 +230.13 13.7916086643317 3.16446317833199 0.812839496318174 +237.39 13.7925085009483 3.1644642311535 0.823657991053274 +239.35 13.7934083378656 3.16446528319119 0.811925113902666 +239.87 13.7943081750835 3.16446633444506 0.804192594897324 +249.49 13.7952080126017 3.1644673849151 0.813900668439589 +271.86 13.79610785042 3.16446843460133 0.804369217357997 +273.51 13.7970076885382 3.16446948350373 0.791278368599934 +286.67 13.797907526956 3.1644705316223 0.78262382554228 +286.9 13.7988073656733 3.16447157895704 0.778630632234475 +290.11 13.7997072046898 3.16447262550796 0.760029114900352 +274.51 13.8006070440052 3.16447367127505 0.750526856579678 +234.62 13.7115255542981 3.16346186477062 0.813856720498114 +232.12 13.7124253624689 3.16346298702525 0.809967644537796 +243.2 13.7133251709603 3.16346410849641 0.797566884108047 +230.55 13.7142249797723 3.16346522918409 0.81750609732492 +226.95 13.7151247889046 3.16346634908829 0.812297811891943 +232.26 13.7160245983568 3.16346746820901 0.816033588239548 +225.66 13.7169244081289 3.16346858654625 0.828045735313445 +223.27 13.7178242182206 3.16346970410001 0.827930909674362 +225.2 13.7187240286317 3.16347082087028 0.825436390366949 +233.37 13.7196238393619 3.16347193685707 0.824968258208043 +232.63 13.720523650411 3.16347305206037 0.824235159606838 +240.16 13.7214234617788 3.16347416648018 0.8328455397191 +238.05 13.722323273465 3.1634752801165 0.821883312909107 +235.77 13.7232230854696 3.16347639296934 0.819125073332336 +242.96 13.7241228977921 3.16347750503868 0.815382305469014 +230.47 13.7250227104325 3.16347861632452 0.817486246166649 +227.13 13.7259225233904 3.16347972682687 0.818610747051114 +233.96 13.7268223366656 3.16348083654573 0.826144104105849 +235.83 13.727722150258 3.16348194548109 0.820076618401403 +239.32 13.7286219641673 3.16348305363295 0.817501706086074 +237.18 13.7295217783933 3.16348416100131 0.843064744647941 +240.32 13.7304215929358 3.16348526758616 0.832289076284019 +238.62 13.7313214077944 3.16348637338752 0.837658170569167 +241.03 13.7322212229691 3.16348747840536 0.822619525914022 +241.99 13.7331210384595 3.16348858263971 0.823770105800726 +240.97 13.7340208542655 3.16348968609054 0.824670215881147 +242.24 13.7349206703869 3.16349078875787 0.824455265705946 +240.74 13.7358204868234 3.16349189064169 0.817676520657742 +238.01 13.7367203035747 3.16349299174199 0.813714316831914 +227.94 13.7376201206407 3.16349409205879 0.817234050132396 +241.78 13.7385199380212 3.16349519159207 0.811840807854482 +249.67 13.7394197557158 3.16349629034183 0.800077405371933 +252.58 13.7403195737245 3.16349738830808 0.81047454981816 +250.42 13.7412193920469 3.16349848549081 0.81736554726812 +245.99 13.7421192106828 3.16349958189002 0.82748448998016 +232.73 13.7430190296321 3.16350067750571 0.828014826686572 +231.73 13.7439188488945 3.16350177233787 0.825121304956781 +231.91 13.7448186684698 3.16350286638652 0.81471637818336 +231.32 13.7457184883576 3.16350395965164 0.806291773215751 +230.02 13.746618308558 3.16350505213323 0.816464470752665 +233.09 13.7475181290705 3.16350614383129 0.816624095359727 +230.4 13.748417949895 3.16350723474583 0.825233995861348 +236.24 13.7493177710312 3.16350832487684 0.835356529670566 +234.88 13.750217592479 3.16350941422431 0.821241959167853 +230.54 13.7511174142381 3.16351050278825 0.818430681150354 +236.74 13.7520172363082 3.16351159056866 0.817873663456434 +236.26 13.7529170586892 3.16351267756553 0.811911538476076 +235.57 13.7538168813809 3.16351376377886 0.817337531088686 +238.87 13.7547167043829 3.16351484920866 0.821308749962556 +246.7 13.7556165276951 3.16351593385492 0.816375834910282 +242.04 13.7565163513173 3.16351701771763 0.811765336518949 +239.8 13.7574161752492 3.16351810079681 0.81651299753221 +237.83 13.7583159994907 3.16351918309244 0.812830398963809 +236.19 13.7592158240414 3.16352026460452 0.817202433979073 +239.27 13.7601156489012 3.16352134533306 0.814307458143075 +245.53 13.7610154740698 3.16352242527805 0.803039666825434 +237.52 13.7619152995471 3.16352350443949 0.80748893065333 +244.49 13.7628151253327 3.16352458281738 0.808847360890428 +239.62 13.7637149514265 3.16352566041172 0.816686626746507 +238.76 13.7646147778282 3.16352673722251 0.81000938909326 +233.18 13.7655146045377 3.16352781324974 0.813901674853982 +233.81 13.7664144315546 3.16352888849342 0.815415703717468 +228.21 13.7673142588789 3.16352996295354 0.8136028014007 +235.49 13.7682140865101 3.1635310366301 0.813618301763049 +243.09 13.7691139144482 3.16353210952311 0.810517349924082 +245.46 13.7700137426929 3.16353318163255 0.805652052161145 +262.75 13.770913571244 3.16353425295843 0.789537263850206 +264.6 13.7718134001012 3.16353532350074 0.820859084399419 +255.47 13.7727132292644 3.16353639325949 0.840070632813602 +251.58 13.7736130587332 3.16353746223468 0.822054511927691 +260.36 13.7745128885076 3.1635385304263 0.808429038769402 +259.37 13.7754127185872 3.16353959783435 0.836044502379725 +257.71 13.7763125489718 3.16354066445882 0.818664403218456 +253.99 13.7772123796612 3.16354173029973 0.832249361347166 +254.67 13.7781122106552 3.16354279535707 0.831288942076304 +253.32 13.7790120419536 3.16354385963083 0.829897108622037 +257.92 13.7799118735561 3.16354492312101 0.825595312060587 +254.12 13.7808117054625 3.16354598582762 0.827076960070535 +244.67 13.7817115376726 3.16354704775065 0.830252660478139 +262.45 13.7826113701862 3.1635481088901 0.809418860520307 +254.62 13.783511203003 3.16354916924597 0.807869183735633 +244.53 13.7844110361228 3.16355022881826 0.81493373283095 +244.57 13.7853108695454 3.16355128760696 0.816294857234673 +240.38 13.7862107032706 3.16355234561208 0.803487841624848 +241.52 13.7871105372981 3.16355340283362 0.805662657092944 +248.4 13.7880103716278 3.16355445927157 0.815391380202977 +233.78 13.7889102062593 3.16355551492592 0.819326664676023 +236.02 13.7898100411925 3.16355656979669 0.820600080248473 +235.84 13.7907098764272 3.16355762388387 0.815124881148396 +230.65 13.7916097119631 3.16355867718746 0.812833930911117 +235.07 13.7925095477999 3.16355972970745 0.822960660778565 +239.41 13.7934093839376 3.16356078144385 0.8139464756879 +254.87 13.7943092203758 3.16356183239665 0.792691252922622 +255.96 13.7952090571143 3.16356288256585 0.820129625592135 +256.12 13.796108894153 3.16356393195146 0.787473743812672 +258.7 13.7970087314915 3.16356498055346 0.791196895274425 +254.68 13.7979085691296 3.16356602837186 0.808649412764274 +260.21 13.7988084070673 3.16356707540666 0.795324931611754 +260.2 13.7997082453041 3.16356812165786 0.804412919182165 +262.85 13.8006080838399 3.16356916712545 0.805164423771831 +232.05 13.7115266709932 3.16255739134389 0.810372228870923 +237.12 13.7124264783847 3.16255851327702 0.808270454965458 +242.92 13.7133262860968 3.16255963442691 0.816691606341225 +232.51 13.7142260941295 3.16256075479355 0.814032042041924 +224.21 13.7151259024824 3.16256187437693 0.831731048504211 +226.62 13.7160257111553 3.16256299317705 0.819852071231747 +227.35 13.7169255201481 3.16256411119392 0.82981555837073 +226.84 13.7178253294605 3.16256522842753 0.823204879191638 +232.81 13.7187251390922 3.16256634487788 0.820632964030059 +232.01 13.719624949043 3.16256746054497 0.827527371997793 +233.68 13.7205247593128 3.1625685754288 0.827440656208525 +240.53 13.7214245699013 3.16256968952936 0.826521273899699 +247.34 13.7223243808082 3.16257080284666 0.829391157242999 +237.27 13.7232241920334 3.16257191538069 0.828645497675198 +233.38 13.7241240035766 3.16257302713146 0.821915910767031 +235.57 13.7250238154376 3.16257413809895 0.81806277304695 +227.71 13.7259236276162 3.16257524828318 0.819602424538529 +236.46 13.7268234401121 3.16257635768413 0.835147119471304 +222.06 13.7277232529252 3.16257746630181 0.829265029434501 +231.76 13.7286230660551 3.16257857413622 0.826622069704473 +242.29 13.7295228795018 3.16257968118735 0.836860070501891 +248.88 13.7304226932649 3.1625807874552 0.813588471637592 +241.71 13.7313225073442 3.16258189293977 0.821636100174178 +237.95 13.7322223217395 3.16258299764107 0.812417447700399 +233.4 13.7331221364506 3.16258410155908 0.807567254935676 +233.3 13.7340219514773 3.16258520469381 0.813182888283797 +239.22 13.7349217668192 3.16258630704525 0.818062260063096 +245.83 13.7358215824763 3.16258740861341 0.826994396565387 +232.8 13.7367213984483 3.16258850939829 0.822234586884519 +235.51 13.737621214735 3.16258960939987 0.801213842233338 +251.29 13.7385210313361 3.16259070861817 0.800237596966312 +247.88 13.7394208482514 3.16259180705317 0.823757197378391 +255.91 13.7403206654807 3.16259290470488 0.824918609883275 +250.47 13.7412204830237 3.1625940015733 0.814028914999747 +242.68 13.7421203008803 3.16259509765842 0.823934023760476 +229.38 13.7430201190502 3.16259619296025 0.829709396879901 +233.09 13.7439199375332 3.16259728747878 0.817421544135369 +229.98 13.7448197563291 3.16259838121401 0.812731417221547 +231.73 13.7457195754376 3.16259947416594 0.811842732175869 +226.8 13.7466193948586 3.16260056633457 0.821284856779453 +229.27 13.7475192145917 3.16260165771989 0.816447274628142 +236.28 13.7484190346368 3.16260274832191 0.83057471672016 +245.72 13.7493188549937 3.16260383814063 0.832144191835209 +240.64 13.7502186756621 3.16260492717604 0.808695316570502 +240.94 13.7511184966418 3.16260601542814 0.82078246504694 +239.95 13.7520183179326 3.16260710289693 0.827973237770756 +237.22 13.7529181395342 3.1626081895824 0.817292989720638 +245.21 13.7538179614464 3.16260927548457 0.796602467490173 +248.91 13.7547177836691 3.16261036060342 0.822979305913494 +249.01 13.755617606202 3.16261144493896 0.802518187347451 +249.75 13.7565174290448 3.16261252849118 0.811611297519936 +239.86 13.7574172521973 3.16261361126008 0.812840707165015 +233.31 13.7583170756593 3.16261469324567 0.828142412206761 +243.38 13.7592168994307 3.16261577444793 0.811364364080689 +242.4 13.7601167235111 3.16261685486687 0.804475521272657 +246.39 13.7610165479003 3.16261793450249 0.800600432870209 +236.11 13.7619163725981 3.16261901335478 0.803208582186445 +243.1 13.7628161976044 3.16262009142375 0.80694653760701 +240.55 13.7637160229188 3.16262116870939 0.824134454269155 +237.62 13.7646158485411 3.1626222452117 0.819254854594444 +234.88 13.7655156744712 3.16262332093069 0.806866336278101 +229.9 13.7664155007087 3.16262439586634 0.814832697600309 +234.22 13.7673153272536 3.16262547001866 0.816315586085064 +242.3 13.7682151541054 3.16262654338764 0.805210996433418 +256.4 13.7691149812641 3.16262761597329 0.822347907077197 +258.18 13.7700148087294 3.16262868777561 0.817911509651784 +245 13.7709146365011 3.16262975879458 0.824308658665373 +251.58 13.7718144645789 3.16263082903022 0.832658336372419 +252.87 13.7727142929626 3.16263189848251 0.839039926148165 +249.75 13.7736141216521 3.16263296715147 0.825618893891768 +254.04 13.774513950647 3.16263403503708 0.813497482290689 +258.66 13.7754137799472 3.16263510213935 0.818356588519796 +254.11 13.7763136095524 3.16263616845827 0.817086579259478 +260.64 13.7772134394624 3.16263723399384 0.813808353640406 +248.5 13.778113269677 3.16263829874607 0.827707200663339 +264.58 13.7790131001959 3.16263936271495 0.818580187198493 +268.04 13.779912931019 3.16264042590047 0.816353761196259 +268.64 13.780812762146 3.16264148830265 0.83474784486681 +261.14 13.7817125935767 3.16264254992147 0.823146246170458 +261.03 13.7826124253108 3.16264361075693 0.814025807157112 +260.13 13.7835122573482 3.16264467080904 0.806765419604964 +249.85 13.7844120896886 3.16264573007779 0.807462459847876 +251.61 13.7853119223318 3.16264678856318 0.798835700248433 +240.1 13.7862117552775 3.16264784626522 0.820545282072923 +241.1 13.7871115885256 3.16264890318389 0.80358398156151 +238.5 13.7880114220758 3.1626499593192 0.826888084830485 +240.03 13.7889112559279 3.16265101467114 0.818122531255327 +238.91 13.7898110900817 3.16265206923972 0.809241207205802 +238.56 13.7907109245369 3.16265312302493 0.820914200483839 +231.71 13.7916107592934 3.16265417602678 0.816789078321928 +234.42 13.7925105943508 3.16265522824525 0.819906024338431 +242.24 13.793410429709 3.16265627968036 0.826489720857464 +248.99 13.7943102653678 3.16265733033209 0.806698502467034 +260.04 13.7952101013269 3.16265838020045 0.763253836731753 +246.29 13.7961099375861 3.16265942928544 0.819689274509874 +249.93 13.7970097741451 3.16266047758705 0.813455267262158 +252.73 13.7979096110039 3.16266152510528 0.811611038909178 +251.6 13.798809448162 3.16266257184014 0.819988662686943 +246.98 13.7997092856194 3.16266361779161 0.817163895710292 +262.91 13.8006091233757 3.16266466295971 0.805601697730709 +232.53 13.7115277873674 3.16165291790096 0.820874838227153 +241.92 13.7124275939798 3.16165403951261 0.807026511023083 +243.14 13.7133274009128 3.16165516034122 0.81062948486086 +229.29 13.7142272081664 3.16165628038681 0.815892817714412 +226.73 13.7151270157402 3.16165739964938 0.812398840964179 +226.19 13.716026823634 3.16165851812891 0.823960419898489 +224.67 13.7169266318477 3.1616596358254 0.815982028983273 +225.62 13.717826440381 3.16166075273887 0.810087965414497 +234.01 13.7187262492336 3.1616618688693 0.818304420711608 +227.06 13.7196260584053 3.16166298421669 0.811952184945914 +224.49 13.720525867896 3.16166409878104 0.830408175479546 +234.67 13.7214256777054 3.16166521256236 0.821219978523349 +240.28 13.7223254878332 3.16166632556063 0.823219406912456 +248.06 13.7232252982793 3.16166743777587 0.823225563669541 +245.3 13.7241251090433 3.16166854920806 0.823088244117471 +245.49 13.7250249201252 3.1616696598572 0.825445379201633 +244.1 13.7259247315247 3.1616707697233 0.824571015164605 +234.9 13.7268245432415 3.16167187880635 0.819175655971112 +217.15 13.7277243552754 3.16167298710636 0.82303205034276 +222.2 13.7286241676263 3.16167409462331 0.824826357691436 +226.78 13.7295239802938 3.16167520135721 0.851752763643313 +236.2 13.7304237932777 3.16167630730806 0.814760618632129 +240.06 13.7313236065779 3.16167741247585 0.798764029553713 +226.84 13.7322234201941 3.16167851686059 0.817710134901418 +228.9 13.7331232341261 3.16167962046227 0.828664047731569 +236.82 13.7340230483736 3.1616807232809 0.824405091720413 +250.46 13.7349228629365 3.16168182531646 0.801358846259684 +239.51 13.7358226778145 3.16168292656896 0.816916929173299 +238.59 13.7367224930073 3.1616840270384 0.819606119951968 +235.64 13.7376223085148 3.16168512672478 0.811461552373538 +243.49 13.7385221243368 3.16168622562809 0.820256204963971 +252.6 13.7394219404729 3.16168732374834 0.81683246828143 +241.3 13.7403217569231 3.16168842108551 0.826458348801607 +247.7 13.741221573687 3.16168951763962 0.817062098688456 +244.18 13.7421213907645 3.16169061341066 0.814186346974341 +234.72 13.7430212081552 3.16169170839862 0.832001149380981 +234.32 13.7439210258591 3.16169280260352 0.828057249747364 +231.21 13.7448208438758 3.16169389602533 0.822703326624837 +222.65 13.7457206622052 3.16169498866407 0.824652451715031 +224.71 13.746620480847 3.16169608051974 0.825340925298138 +220.73 13.747520299801 3.16169717159233 0.824782945766333 +230.56 13.748420119067 3.16169826188183 0.831830745049619 +248.37 13.7493199386447 3.16169935138826 0.819591529370479 +240.8 13.7502197585339 3.1617004401116 0.822007545612639 +237.54 13.7511195787344 3.16170152805186 0.814433068401322 +241.02 13.7520193992461 3.16170261520903 0.80867081033085 +240.64 13.7529192200685 3.16170370158311 0.824154803951771 +246.64 13.7538190412016 3.16170478717411 0.803578237497477 +231.25 13.7547188626451 3.16170587198202 0.803279373019286 +238.62 13.7556186843988 3.16170695600684 0.815030831989375 +248.1 13.7565185064625 3.16170803924856 0.805724795953558 +232.47 13.7574183288358 3.1617091217072 0.80962783863419 +227.05 13.7583181515187 3.16171020338274 0.820926233032369 +231.47 13.7592179745109 3.16171128427518 0.83213794667536 +238.1 13.7601177978121 3.16171236438452 0.813377218583947 +239.83 13.7610176214222 3.16171344371077 0.801496192478025 +249.04 13.7619174453408 3.16171452225391 0.797827110254035 +245.46 13.7628172695679 3.16171560001396 0.813029925890276 +241.3 13.7637170941031 3.1617166769909 0.823396104444665 +239.02 13.7646169189463 3.16171775318474 0.808316066615775 +234.66 13.7655167440972 3.16171882859547 0.823861076909216 +227.15 13.7664165695555 3.1617199032231 0.818109303427579 +234.64 13.7673163953212 3.16172097706761 0.818329872244928 +250.66 13.7682162213939 3.16172205012902 0.803360113614818 +256.81 13.7691160477734 3.16172312240732 0.823002828325951 +248.51 13.7700158744595 3.16172419390251 0.824342858664678 +245.16 13.770915701452 3.16172526461458 0.816781681754925 +245.54 13.7718155287506 3.16172633454354 0.805107066018079 +248.13 13.7727153563552 3.16172740368938 0.820463598061631 +256.74 13.7736151842654 3.1617284720521 0.835447458724091 +262.01 13.7745150124811 3.16172953963171 0.809610731120529 +259.61 13.7754148410021 3.1617306064282 0.806137982536765 +257.49 13.7763146698281 3.16173167244156 0.815140478116643 +266.59 13.777214498959 3.1617327376718 0.805552629380333 +254.54 13.7781143283944 3.16173380211892 0.827111157850457 +263.68 13.7790141581341 3.16173486578292 0.825861271639932 +263.3 13.779913988178 3.16173592866378 0.820107937905684 +266.57 13.7808138185258 3.16173699076152 0.826637277809837 +273.24 13.7817136491773 3.16173805207613 0.819653902286469 +264.11 13.7826134801322 3.16173911260761 0.83349129036902 +252.3 13.7835133113904 3.16174017235596 0.823292845579776 +252.83 13.7844131429516 3.16174123132118 0.822770845245703 +242.68 13.7853129748156 3.16174228950326 0.817265768820851 +237.04 13.7862128069821 3.1617433469022 0.811367700209245 +235.02 13.787112639451 3.16174440351801 0.818849194555073 +244.26 13.788012472222 3.16174545935068 0.810652809353686 +233.84 13.7889123052949 3.16174651440021 0.813654404057614 +231 13.7898121386695 3.1617475686666 0.813077236463743 +230.98 13.7907119723455 3.16174862214985 0.815819033969865 +232.17 13.7916118063227 3.16174967484996 0.810786479422881 +243.92 13.7925116406009 3.16175072676692 0.819641468591724 +265.54 13.7934114751799 3.16175177790073 0.795836242756777 +259.22 13.7943113100595 3.1617528282514 0.768626934089029 +245.69 13.7952111452393 3.16175387781891 0.813524265267588 +247.41 13.7961109807193 3.16175492660328 0.816189212508791 +246.5 13.7970108164991 3.1617559746045 0.815674603888603 +248.69 13.7979106525786 3.16175702182256 0.812868562442668 +243.02 13.7988104889576 3.16175806825747 0.817516888127345 +250.81 13.7997103256357 3.16175911390923 0.800512887588834 +262.41 13.8006101626128 3.16176015877783 0.812107078384131 +238.22 13.7115289034207 3.16074844444185 0.821575588613247 +241.48 13.7124287092541 3.160749565732 0.823160721755668 +241.39 13.7133285154083 3.16075068623935 0.81392593470228 +231.96 13.714228321883 3.1607518059639 0.814816941742183 +233.22 13.715128128678 3.16075292490564 0.81187373479314 +229.54 13.7160279357929 3.16075404306458 0.819172862106325 +221.77 13.7169277432277 3.16075516044071 0.816721555956006 +225.42 13.7178275509821 3.16075627703402 0.820054217310094 +235.85 13.7187273590558 3.16075739284453 0.817258305146514 +225.52 13.7196271674487 3.16075850787223 0.82910160602594 +228.48 13.7205269761605 3.16075962211711 0.8257281480026 +233.66 13.7214267851909 3.16076073557918 0.823183566269581 +240.01 13.7223265945399 3.16076184825843 0.823981261911343 +244.3 13.7232264042071 3.16076296015486 0.830274697941299 +255.93 13.7241262141923 3.16076407126848 0.827169298239767 +236.32 13.7250260244953 3.16076518159927 0.822427015202967 +231.94 13.7259258351158 3.16076629114725 0.81953201844965 +227.41 13.7268256460537 3.1607673999124 0.810912038117225 +217.1 13.7277254573088 3.16076850789472 0.811919185249988 +232.4 13.7286252688807 3.16076961509423 0.825140514743354 +233.3 13.7295250807693 3.1607707215109 0.844549615846825 +244.11 13.7304248929744 3.16077182714474 0.827498961783151 +232.75 13.7313247054957 3.16077293199576 0.828341316665693 +227.07 13.732224518333 3.16077403606394 0.824576280642246 +240.6 13.733124331486 3.16077513934929 0.838701124816894 +249.18 13.7340241449547 3.16077624185181 0.819497125874946 +247.51 13.7349239587386 3.1607773435715 0.818238380067591 +243.34 13.7358237728377 3.16077844450834 0.807125152771591 +242.87 13.7367235872516 3.16077954466235 0.824645517396753 +235.36 13.7376234019802 3.16078064403352 0.81804084532326 +234.87 13.7385232170233 3.16078174262185 0.821962615071619 +244.05 13.7394230323805 3.16078284042733 0.818154395314346 +237.39 13.7403228480517 3.16078393744997 0.80774162463767 +242.98 13.7412226640367 3.16078503368977 0.814249993536497 +241.01 13.7421224803353 3.16078612914672 0.815778134379365 +231.64 13.7430222969471 3.16078722382083 0.806149866455237 +225.66 13.7439221138721 3.16078831771209 0.823952494879946 +229.15 13.7448219311099 3.16078941082049 0.823254706274164 +228.36 13.7457217486603 3.16079050314605 0.826441804732191 +229.29 13.7466215665232 3.16079159468875 0.830077195343228 +225.41 13.7475213846983 3.16079268544859 0.833655486474888 +237.95 13.7484212031853 3.16079377542559 0.817383441187525 +247.46 13.7493210219841 3.16079486461972 0.822204659400833 +240.9 13.7502208410944 3.160795953031 0.808614757721952 +238.06 13.751120660516 3.16079704065941 0.805221087505177 +243.93 13.7520204802487 3.16079812750497 0.82534507344492 +234.5 13.7529203002922 3.16079921356766 0.827396836028795 +230.48 13.7538201206464 3.16080029884749 0.813557613608415 +239.1 13.754719941311 3.16080138334446 0.794969435815212 +237.45 13.7556197622857 3.16080246705856 0.810288568168944 +251.24 13.7565195835704 3.16080354998979 0.811951400572241 +233.99 13.7574194051648 3.16080463213815 0.819319267040707 +227.53 13.7583192270688 3.16080571350365 0.821953070478181 +234.17 13.759219049282 3.16080679408627 0.815200881210505 +238.3 13.7601188718043 3.16080787388602 0.814163047844243 +233.9 13.7610186946354 3.16080895290289 0.818394450100484 +244.63 13.7619185177751 3.16081003113689 0.805792996025762 +245.77 13.7628183412232 3.16081110858801 0.813621758343566 +237.03 13.7637181649795 3.16081218525625 0.810813924021471 +244.15 13.7646179890437 3.16081326114162 0.804993618558206 +241.24 13.7655178134157 3.1608143362441 0.807421324565524 +236.57 13.7664176380951 3.1608154105637 0.808246553527658 +239.71 13.7673174630818 3.16081648410042 0.820473085360725 +237.25 13.7682172883755 3.16081755685425 0.820986184333452 +235.39 13.7691171139761 3.1608186288252 0.818582531905885 +242.88 13.7700169398832 3.16081970001326 0.824597419588303 +245.41 13.7709167660967 3.16082077041842 0.84650339570941 +244.7 13.7718165926164 3.1608218400407 0.841284941889042 +243.63 13.772716419442 3.16082290888009 0.846907448509212 +253.6 13.7736162465733 3.16082397693659 0.851958174625351 +252.36 13.7745160740101 3.16082504421019 0.843762985124242 +257.12 13.7754159017521 3.1608261107009 0.830848810286221 +255.18 13.7763157297991 3.1608271764087 0.811816468563119 +263.11 13.777215558151 3.16082824133362 0.810714544269891 +253.65 13.7781153868074 3.16082930547563 0.811505677671717 +259.58 13.7790152157682 3.16083036883474 0.824123498324481 +273.08 13.7799150450331 3.16083143141095 0.827487104363101 +265.49 13.7808148746019 3.16083249320425 0.808871049441586 +267.41 13.7817147044744 3.16083355421466 0.812531382374648 +275.23 13.7826145346504 3.16083461444215 0.83305316461722 +262.43 13.7835143651296 3.16083567388674 0.807018332290482 +256.3 13.7844141959118 3.16083673254842 0.81029552945417 +250.96 13.7853140269968 3.16083779042719 0.816264084380287 +234.08 13.7862138583843 3.16083884752305 0.818781330872107 +233.9 13.7871136900742 3.16083990383599 0.818753613997128 +231.73 13.7880135220663 3.16084095936603 0.819601845828435 +239.67 13.7889133543602 3.16084201411314 0.811427953638014 +232.22 13.7898131869557 3.16084306807735 0.818122830607586 +232.17 13.7907130198528 3.16084412125863 0.815700154973501 +234.39 13.791612853051 3.16084517365699 0.806146254280314 +242.26 13.7925126865502 3.16084622527244 0.828695070775082 +270.14 13.7934125203502 3.16084727610496 0.759408690479073 +245.92 13.7943123544508 3.16084832615456 0.806561060554994 +243.33 13.7952121888517 3.16084937542124 0.817897414866243 +244.29 13.7961120235526 3.16085042390499 0.826303151507731 +242.93 13.7970118585535 3.16085147160581 0.820521822215627 +241.47 13.797911693854 3.16085251852371 0.811352575160177 +240.01 13.7988115294539 3.16085356465867 0.81415841659501 +243.42 13.7997113653531 3.16085461001071 0.80793506966226 +258.78 13.8006112015512 3.16085565457981 0.799107363303136 +246.7 13.711530019153 3.15984397096656 0.811698433297325 +247.56 13.7124298242078 3.15984509193522 0.82066084818513 +245.19 13.7133296295834 3.1598462121213 0.819021715667228 +241.28 13.7142294352794 3.15984733152481 0.806666256403945 +237.1 13.7151292412957 3.15984845014573 0.822126620718401 +226.33 13.716029047632 3.15984956798407 0.820188088736154 +222.07 13.7169288542881 3.15985068503983 0.826762193279231 +227.41 13.7178286612638 3.159851801313 0.820800807382658 +235.66 13.7187284685589 3.15985291680359 0.821490346493574 +228.5 13.7196282761731 3.15985403151159 0.827747776655521 +233.08 13.7205280841062 3.159855145437 0.822276410032699 +229.9 13.7214278923581 3.15985625857982 0.815747229043987 +234.82 13.7223277009283 3.15985737094005 0.821676116082389 +240.26 13.7232275098169 3.15985848251769 0.821093156486603 +238.89 13.7241273190234 3.15985959331273 0.826006990469827 +227.37 13.7250271285477 3.15986070332517 0.823162680430934 +230.28 13.7259269383896 3.15986181255502 0.813915844702618 +231.23 13.7268267485489 3.15986292100227 0.812380269143141 +219.4 13.7277265590252 3.15986402866692 0.831116825168743 +231.23 13.7286263698185 3.15986513554897 0.82602643356434 +239.7 13.7295261809284 3.15986624164842 0.828495190243522 +240.93 13.7304259923548 3.15986734696526 0.855717669797645 +233.14 13.7313258040974 3.1598684514995 0.833867732640262 +225.2 13.732225616156 3.15986955525113 0.834073130154685 +228.74 13.7331254285304 3.15987065822015 0.824411603721949 +230.68 13.7340252412204 3.15987176040656 0.827320836214771 +243.67 13.7349250542256 3.15987286181036 0.827250446179685 +231.47 13.735824867546 3.15987396243155 0.828443496645451 +230.83 13.7367246811813 3.15987506227013 0.821982774691473 +240.49 13.7376244951312 3.15987616132609 0.815928097265994 +234.92 13.7385243093955 3.15987725959944 0.827544945131917 +238.6 13.7394241239741 3.15987835709016 0.821276658702037 +241.7 13.7403239388666 3.15987945379827 0.816330251334809 +237.23 13.7412237540729 3.15988054972376 0.820254190458648 +244.38 13.7421235695928 3.15988164486663 0.811883245039992 +230.37 13.7430233854259 3.15988273922687 0.819358764045809 +229.13 13.7439232015722 3.15988383280449 0.833518453427065 +234.55 13.7448230180313 3.15988492559949 0.818484119624435 +234.02 13.7457228348031 3.15988601761185 0.820037236227963 +230.25 13.7466226518872 3.15988710884159 0.835444786759322 +234.84 13.7475224692836 3.1598881992887 0.824689179075301 +239.09 13.7484222869919 3.15988928895318 0.817682430599512 +245.92 13.749322105012 3.15989037783503 0.809420940729708 +243.33 13.7502219233436 3.15989146593424 0.805700375606145 +239.6 13.7511217419865 3.15989255325081 0.811460201739667 +239.65 13.7520215609405 3.15989363978476 0.809499530701399 +234.26 13.7529213802053 3.15989472553606 0.807133677650881 +238.81 13.7538211997808 3.15989581050472 0.805243924867463 +231.82 13.7547210196666 3.15989689469074 0.799133114267814 +232.8 13.7556208398627 3.15989797809412 0.814116503955952 +238.59 13.7565206603686 3.15989906071486 0.821060971817011 +234.99 13.7574204811844 3.15990014255296 0.815207480102002 +243.34 13.7583203023096 3.15990122360841 0.807936855952642 +242.76 13.7592201237441 3.15990230388121 0.816517256750115 +246.91 13.7601199454876 3.15990338337136 0.814804013286721 +237.29 13.76101976754 3.15990446207886 0.823365226849547 +245.24 13.761919589901 3.15990554000371 0.815893256211384 +240.89 13.7628194125704 3.15990661714591 0.824003323167066 +242.63 13.763719235548 3.15990769350546 0.805003782680267 +242.76 13.7646190588335 3.15990876908235 0.81895887795724 +247.07 13.7655188824267 3.15990984387658 0.815201870592856 +242.89 13.7664187063274 3.15991091788816 0.805863136576319 +237.05 13.7673185305353 3.15991199111707 0.821627489145082 +237.01 13.7682183550503 3.15991306356333 0.817135059064352 +229.12 13.7691181798722 3.15991413522693 0.812568478595687 +233.84 13.7700180050006 3.15991520610786 0.834272794305224 +247.2 13.7709178304354 3.15991627620613 0.846841928439442 +247.62 13.7718176561763 3.15991734552173 0.847148134812695 +251.16 13.7727174822231 3.15991841405466 0.853524547504771 +259.72 13.7736173085757 3.15991948180493 0.844604920844173 +266.03 13.7745171352337 3.15992054877253 0.839474931370883 +270.16 13.775416962197 3.15992161495745 0.836355233537576 +269.13 13.7763167894653 3.15992268035971 0.822548069024832 +261.71 13.7772166170384 3.15992374497929 0.81979726368569 +251.03 13.7781164449161 3.15992480881619 0.829941774009134 +249.87 13.7790162730981 3.15992587187042 0.826148945329315 +251.51 13.7799161015843 3.15992693414197 0.828539514102206 +262.92 13.7808159303743 3.15992799563085 0.814880419050245 +257.88 13.7817157594681 3.15992905633704 0.809138822451055 +262.94 13.7826155888653 3.15993011626055 0.8177179502452 +249.96 13.7835154185658 3.15993117540138 0.82273043921502 +251.89 13.7844152485692 3.15993223375952 0.822385165434493 +251.68 13.7853150788754 3.15993329133498 0.802328042328042 +239.7 13.7862149094842 3.15993434812775 0.816368778827106 +227.47 13.7871147403954 3.15993540413784 0.82737464987572 +236.33 13.7880145716086 3.15993645936523 0.828142076502732 +246.32 13.7889144031238 3.15993751380994 0.810718154306581 +248.33 13.7898142349406 3.15993856747195 0.807288978602532 +239.99 13.7907140670589 3.15993962035127 0.816825160187632 +239.57 13.7916138994783 3.1599406724479 0.813995846590584 +240.89 13.7925137321988 3.15994172376183 0.814587449602286 +249.87 13.79341356522 3.15994277429306 0.791392647101428 +247.33 13.7943133985418 3.15994382404159 0.807682303592036 +243.45 13.7952132321639 3.15994487300743 0.81798865319987 +239.09 13.7961130660861 3.15994592119056 0.815066330354459 +240.89 13.7970129003082 3.15994696859099 0.810182246457169 +244.28 13.7979127348299 3.15994801520872 0.809815179581744 +241.44 13.7988125696511 3.15994906104374 0.80352561449971 +243.87 13.7997124047714 3.15995010609606 0.800566259772642 +246.2 13.8006122401908 3.15995115036567 0.795183466992724 +240.81 13.7115311345644 3.15893949747509 0.803105776559625 +236.4 13.7124309388408 3.15894061812226 0.808957867263236 +238.92 13.7133307434379 3.15894173798708 0.801472315452942 +244.36 13.7142305483555 3.15894285706954 0.787235389796702 +234.21 13.7151303535934 3.15894397536964 0.822076557456025 +230.47 13.7160301591513 3.15894509288739 0.8279927618491 +226.69 13.716929965029 3.15894620962278 0.828914325979565 +231.18 13.7178297712262 3.15894732557581 0.814600773870927 +231.16 13.7187295777429 3.15894844074648 0.829268642790497 +229.28 13.7196293845787 3.15894955513478 0.831146700555263 +234.39 13.7205291917333 3.15895066874072 0.815833476165991 +237.88 13.7214289992067 3.1589517815643 0.83358087731442 +230.49 13.7223288069986 3.1589528936055 0.818334400224828 +234.51 13.7232286151086 3.15895400486434 0.821047517396777 +232.98 13.7241284235367 3.15895511534081 0.828691860465116 +225.46 13.7250282322826 3.1589562250349 0.818053602202722 +222.54 13.7259280413461 3.15895733394663 0.809702576102556 +227.22 13.7268278507269 3.15895844207598 0.805867662850066 +224.05 13.7277276604248 3.15895954942295 0.827037227783814 +228.01 13.7286274704396 3.15896065598755 0.813118109354888 +229.88 13.7295272807711 3.15896176176977 0.817955567999316 +230.85 13.730427091419 3.15896286676961 0.834147651196394 +227.15 13.7313269023832 3.15896397098707 0.81425735314193 +237.06 13.7322267136633 3.15896507442215 0.809489379540568 +239.41 13.7331265252593 3.15896617707484 0.802862762153653 +244.65 13.7340263371707 3.15896727894515 0.82097008746234 +238.41 13.7349261493976 3.15896838003307 0.831821946460407 +235.85 13.7358259619395 3.1589694803386 0.825051801893308 +234.29 13.7367257747963 3.15897057986175 0.817234246622832 +235.21 13.7376255879677 3.15897167860251 0.813862093604859 +229.43 13.7385254014536 3.15897277656087 0.826359341900607 +240.78 13.7394252152537 3.15897387373684 0.818270548266607 +251.61 13.7403250293678 3.15897497013041 0.80644920169826 +244.2 13.7412248437956 3.15897606574159 0.826313775465425 +234.46 13.742124658537 3.15897716057038 0.823179769840974 +226.16 13.7430244735917 3.15897825461676 0.824397621779493 +223.18 13.7439242889595 3.15897934788074 0.832311735427826 +232.57 13.7448241046401 3.15898044036233 0.81910570626754 +232.22 13.7457239206334 3.15898153206151 0.818824871648602 +235.38 13.7466237369391 3.15898262297828 0.823032662103335 +237.95 13.747523553557 3.15898371311266 0.823514443448726 +235.18 13.7484233704868 3.15898480246462 0.81763900789789 +240.42 13.7493231877284 3.15898589103418 0.82339853122955 +241.2 13.7502230052815 3.15898697882132 0.823659275318997 +237.19 13.751122823146 3.15898806582606 0.823539969935608 +236.97 13.7520226413214 3.15898915204839 0.810046232761587 +241.52 13.7529224598078 3.1589902374883 0.818948330910018 +232.01 13.7538222786048 3.1589913221458 0.808371693812526 +230.82 13.7547220977121 3.15899240602088 0.811869567975639 +238.84 13.7556219171297 3.15899348911354 0.799723239594873 +238.55 13.7565217368572 3.15899457142379 0.827587919377381 +242.77 13.7574215568944 3.15899565295161 0.823693605499612 +247.82 13.7583213772411 3.15899673369701 0.80458852985453 +245.44 13.7592211978971 3.15899781366 0.815767957079975 +245.07 13.7601210188622 3.15899889284055 0.804991381248595 +248.06 13.7610208401361 3.15899997123868 0.808859172586711 +233.49 13.7619206617186 3.15900104885439 0.823808689101142 +231.18 13.7628204836095 3.15900212568767 0.826191426754795 +235.28 13.7637203058085 3.15900320173851 0.822838983368435 +239.9 13.7646201283155 3.15900427700693 0.822211681507514 +247.44 13.7655199511302 3.15900535149292 0.821451188449035 +240.94 13.7664197742524 3.15900642519647 0.824567131445119 +244.48 13.7673195976818 3.15900749811759 0.818535108562363 +245.32 13.7682194214183 3.15900857025627 0.815739149559571 +234.73 13.7691192454616 3.15900964161251 0.821892570005311 +239.97 13.7700190698116 3.15901071218632 0.83170783108596 +266.6 13.7709188944678 3.15901178197768 0.833835276402009 +262.42 13.7718187194302 3.15901285098661 0.83549210551196 +275.5 13.7727185446986 3.15901391921309 0.831232825617549 +286.98 13.7736183702726 3.15901498665713 0.821053524060997 +281.82 13.7745181961521 3.15901605331872 0.82184929984441 +303.35 13.7754180223369 3.15901711919787 0.811995753399808 +297.74 13.7763178488267 3.15901818429457 0.806123389997234 +289.78 13.7772176756212 3.15901924860882 0.80221022147164 +269.97 13.7781175027204 3.15902031214062 0.818584826333068 +249.98 13.7790173301239 3.15902137488997 0.819262799365159 +250.01 13.7799171578315 3.15902243685686 0.816766864872954 +250.98 13.7808169858431 3.1590234980413 0.817800252844501 +250.89 13.7817168141583 3.15902455844329 0.812602014557753 +237.14 13.782616642777 3.15902561806281 0.815921958907308 +241.17 13.7835164716989 3.15902667689988 0.808823585145209 +250.84 13.7844163009238 3.15902773495449 0.819053212240703 +239.72 13.7853161304515 3.15902879222664 0.814008776979493 +232.34 13.7862159602818 3.15902984871633 0.818453377475969 +229.01 13.7871157904144 3.15903090442355 0.810980142295848 +243.88 13.7880156208491 3.15903195934831 0.797356932901273 +245.96 13.7889154515857 3.1590330134906 0.818531948754097 +248.66 13.789815282624 3.15903406685043 0.808452667833465 +233.47 13.7907151139637 3.15903511942778 0.817356120092379 +230.15 13.7916149456047 3.15903617122267 0.822526365549765 +238.98 13.7925147775466 3.15903722223509 0.812939046288157 +251.97 13.7934146097893 3.15903827246503 0.79222298743326 +241.62 13.7943144423325 3.1590393219125 0.805926420839621 +243.18 13.7952142751761 3.15904037057749 0.789241406364929 +236.22 13.7961141083197 3.15904141846001 0.810156210047638 +240.64 13.7970139417632 3.15904246556005 0.800390366601606 +239.33 13.7979137755064 3.15904351187761 0.805019312667129 +241.31 13.798813609549 3.15904455741269 0.801796861651189 +245.63 13.7997134438908 3.15904560216529 0.804617200456938 +238.99 13.8006132785316 3.1590466461354 0.799293072766159 +237.17 13.7115322496549 3.15803502396745 0.827109102869652 +234.6 13.7124320531531 3.15803614429313 0.797123341920575 +237.32 13.713331856972 3.15803726383668 0.799931537928784 +234.93 13.7142316611114 3.1580383825981 0.802104668978308 +221.84 13.715131465571 3.15803950057739 0.820216511109212 +230.41 13.7160312703507 3.15804061777455 0.804504810038629 +220.4 13.7169310754502 3.15804173418957 0.826855261211748 +223.31 13.7178308808693 3.15804284982245 0.806271595170257 +227.88 13.7187306866077 3.1580439646732 0.806522242051689 +228.45 13.7196304926653 3.15804507874181 0.815400496277916 +234.09 13.7205302990417 3.15804619202828 0.819942501490985 +237.91 13.7214301057369 3.1580473045326 0.826899864068872 +229.74 13.7223299127505 3.15804841625479 0.827611711704981 +233.31 13.7232297200824 3.15804952719483 0.815967234522467 +233.75 13.7241295277323 3.15805063735273 0.821934628509443 +225.89 13.7250293356999 3.15805174672847 0.827008669364818 +234.04 13.7259291439852 3.15805285532207 0.812298343624424 +228.08 13.7268289525877 3.15805396313352 0.818493641238071 +226.02 13.7277287615074 3.15805507016282 0.82522123058213 +226.49 13.728628570744 3.15805617640997 0.82163603177849 +228.99 13.7295283802973 3.15805728187496 0.832317733527789 +227.88 13.730428190167 3.1580583865578 0.833796940194715 +214.81 13.7313280003529 3.15805949045848 0.83480850236052 +241.06 13.7322278108548 3.15806059357701 0.833061202639222 +234.81 13.7331276216725 3.15806169591337 0.834163752462889 +237.14 13.7340274328058 3.15806279746758 0.821297519989959 +234.64 13.7349272442544 3.15806389823962 0.830931939249688 +237.48 13.735827056018 3.1580649982295 0.814550416113858 +248.63 13.7367268680966 3.15806609743721 0.815078605503498 +232.86 13.7376266804898 3.15806719586276 0.822705135249287 +234.92 13.7385264931975 3.15806829350614 0.826159116695613 +242.74 13.7394263062193 3.15806939036736 0.82407569151572 +246.09 13.7403261195552 3.1580704864464 0.804154652841425 +239.67 13.7412259332047 3.15807158174327 0.808567672452931 +228.44 13.7421257471679 3.15807267625797 0.824878990304145 +230.48 13.7430255614443 3.15807376999049 0.823325312837068 +236.64 13.7439253760338 3.15807486294084 0.826903833484679 +228.44 13.7448251909362 3.15807595510902 0.824002985910236 +227.73 13.7457250061513 3.15807704649501 0.826157238937794 +238.49 13.7466248216787 3.15807813709883 0.814874300622842 +243.76 13.7475246375183 3.15807922692046 0.81889495950169 +250.52 13.7484244536699 3.15808031595991 0.80576426965109 +245.24 13.7493242701333 3.15808140421718 0.817599435042498 +241.63 13.7502240869082 3.15808249169226 0.829019746121298 +242.29 13.7511239039943 3.15808357838516 0.8238212773624 +238.2 13.7520237213915 3.15808466429587 0.811072724679482 +239.56 13.7529235390996 3.15808574942439 0.820802652462709 +235.34 13.7538233571183 3.15808683377072 0.812242996097618 +231.92 13.7547231754474 3.15808791733486 0.824990233007276 +240.65 13.7556229940867 3.15808900011681 0.828636170514091 +242.63 13.7565228130359 3.15809008211656 0.814140217639848 +241.98 13.7574226322949 3.15809116333412 0.820799499858245 +243.25 13.7583224518633 3.15809224376948 0.815421220460732 +242.09 13.7592222717411 3.15809332342264 0.811263016868644 +236.44 13.7601220919279 3.1580944022936 0.814782427649386 +235.75 13.7610219124235 3.15809548038237 0.812350573915112 +238.1 13.7619217332277 3.15809655768893 0.80296492842658 +229.5 13.7628215543403 3.15809763421328 0.809446134523004 +234.11 13.7637213757611 3.15809870995543 0.805082251365405 +238.03 13.7646211974898 3.15809978491538 0.823535944325165 +242 13.7655210195262 3.15810085909311 0.820255592513377 +241.3 13.7664208418701 3.15810193248864 0.814744566882711 +240.91 13.7673206645213 3.15810300510196 0.820315467651105 +245.11 13.7682204874795 3.15810407693307 0.807729550275122 +236.75 13.7691203107445 3.15810514798196 0.82430965787001 +239.88 13.7700201343162 3.15810621824864 0.823979988360282 +250.1 13.7709199581941 3.15810728773311 0.840710280373832 +277.7 13.7718197823783 3.15810835643536 0.835537550567756 +277.09 13.7727196068683 3.15810942435539 0.83114484962527 +292.68 13.7736194316641 3.1581104914932 0.811195556947172 +291.04 13.7745192567653 3.15811155784879 0.804605811380754 +304.76 13.7754190821717 3.15811262342215 0.812819336616496 +304.85 13.7763189078832 3.1581136882133 0.792837812322991 +305.93 13.7772187338995 3.15811475222222 0.777370825582922 +280.94 13.7781185602204 3.15811581544891 0.784435925442072 +254.58 13.7790183868456 3.15811687789338 0.827789428367356 +242.38 13.7799182137749 3.15811793955562 0.815232237888027 +248.01 13.7808180410082 3.15811900043563 0.8160377873046 +241.96 13.7817178685451 3.1581200605334 0.811213324148116 +229.63 13.7826176963855 3.15812111984895 0.815154282103738 +237.71 13.7835175245291 3.15812217838226 0.807210485450395 +237.4 13.7844173529757 3.15812323613333 0.814861973555978 +230.87 13.7853171817251 3.15812429310217 0.812413270611155 +228.71 13.786217010777 3.15812534928877 0.815333619311313 +244.05 13.7871168401313 3.15812640469314 0.806925555314601 +252.66 13.7880166697877 3.15812745931526 0.798076599373829 +240.43 13.788916499746 3.15812851315514 0.815559868807336 +242.52 13.789816330006 3.15812956621278 0.805049457438739 +231.66 13.7907161605674 3.15813061848817 0.820022539871667 +229.53 13.79161599143 3.15813166998132 0.821644158161926 +247.64 13.7925158225936 3.15813272069222 0.820541037499303 +253.21 13.793415654058 3.15813377062087 0.772328300769686 +240.98 13.7943154858229 3.15813481976728 0.809255777739798 +236.96 13.7952153178881 3.15813586813143 0.809943566065016 +233.44 13.7961151502534 3.15813691571333 0.807751193055035 +232.42 13.7970149829186 3.15813796251298 0.81065191899344 +239.2 13.7979148158835 3.15813900853037 0.804860560625555 +235.41 13.7988146491478 3.15814005376551 0.80218902227748 +232.93 13.7997144827112 3.15814109821839 0.816404277061497 +239.31 13.8006143165737 3.15814214188901 0.800134475689188 +240.83 13.7115333644244 3.15713055044365 0.814674058670571 +231.05 13.7124331671446 3.15713167044784 0.819340188452921 +235.8 13.7133329701856 3.15713278967012 0.812541655911576 +231.77 13.714232773547 3.1571339081105 0.808982425013521 +232.04 13.7151325772287 3.15713502576897 0.813753816280457 +226.53 13.7160323812304 3.15713614264554 0.830075120929092 +233.3 13.7169321855519 3.15713725874019 0.813835688942035 +225.26 13.717831990193 3.15713837405293 0.817430464830814 +226.16 13.7187317951534 3.15713948858376 0.824121324835756 +236.41 13.719631600433 3.15714060233267 0.806362160432624 +239.37 13.7205314060315 3.15714171529967 0.815858009544312 +236.96 13.7214312119486 3.15714282748475 0.833504725527643 +228.77 13.7223310181843 3.15714393888792 0.818272488484526 +231.9 13.7232308247381 3.15714504950916 0.82341993597856 +240.74 13.72413063161 3.15714615934848 0.820090726779414 +230.32 13.7250304387997 3.15714726840588 0.82464380421592 +230.39 13.7259302463069 3.15714837668136 0.80718849446185 +228.4 13.7268300541315 3.15714948417491 0.818560854492645 +226.02 13.7277298622732 3.15715059088654 0.826149987789798 +219.8 13.7286296707318 3.15715169681623 0.83293033068503 +230.95 13.729529479507 3.157152801964 0.826252697457544 +230.7 13.7304292885987 3.15715390632984 0.841507831728951 +226.51 13.7313290980067 3.15715500991374 0.834427307945326 +239.46 13.7322289077306 3.15715611271571 0.829971061272191 +223.71 13.7331287177703 3.15715721473575 0.827284086514146 +232.6 13.7340285281255 3.15715831597385 0.824390958713412 +239.27 13.7349283387961 3.15715941643002 0.839381731268567 +240.64 13.7358281497817 3.15716051610424 0.813677239145535 +241.64 13.7367279610823 3.15716161499653 0.810989931630836 +232.6 13.7376277726975 3.15716271310687 0.819465376972969 +235.96 13.7385275846271 3.15716381043527 0.804426025308204 +246.76 13.739427396871 3.15716490698173 0.802885324269162 +244.3 13.7403272094288 3.15716600274624 0.815916717111704 +240.01 13.7412270223003 3.1571670977288 0.818609569125033 +233.3 13.7421268354855 3.15716819192942 0.825070671180684 +237.89 13.7430266489839 3.15716928534808 0.806729258478636 +235.95 13.7439264627954 3.1571703779848 0.812709524940525 +232.46 13.7448262769197 3.15717146983956 0.82105136339906 +237.77 13.7457260913567 3.15717256091237 0.837385136586101 +230.72 13.7466259061062 3.15717365120322 0.817426726730134 +239.18 13.7475257211678 3.15717474071212 0.813329168840963 +246.19 13.7484255365413 3.15717582943906 0.815872115845946 +250.66 13.7493253522266 3.15717691738404 0.814283286508221 +249.07 13.7502251682235 3.15717800454706 0.838513599795684 +245.14 13.7511249845316 3.15717909092812 0.811975214404382 +253.51 13.7520248011508 3.15718017652721 0.800463462661854 +251.18 13.7529246180808 3.15718126134435 0.814433445451833 +234.77 13.7538244353215 3.15718234537951 0.81506833756105 +238.05 13.7547242528726 3.15718342863271 0.822475903526349 +249.49 13.7556240707338 3.15718451110394 0.822430367613893 +231.41 13.756523888905 3.1571855927932 0.820130862475704 +240.74 13.7574237073859 3.15718667370049 0.819391448265828 +243.33 13.7583235261763 3.15718775382581 0.824912559675125 +243.96 13.759223345276 3.15718883316915 0.818566213224132 +243.67 13.7601231646847 3.15718991173052 0.810747916643321 +234.58 13.7610229844023 3.15719098950991 0.812469879993996 +226.82 13.7619228044285 3.15719206650732 0.820532153878442 +222.35 13.762822624763 3.15719314272276 0.818137814475239 +228.16 13.7637224454058 3.15719421815621 0.816013009914814 +242.77 13.7646222663564 3.15719529280769 0.804871721296977 +233.69 13.7655220876148 3.15719636667718 0.816154333393286 +241.41 13.7664219091806 3.15719743976468 0.81513341145283 +241.92 13.7673217310537 3.1571985120702 0.816683292054329 +236.1 13.7682215532339 3.15719958359373 0.81296707260651 +243.73 13.7691213757209 3.15720065433528 0.811496478410801 +243.48 13.7700211985144 3.15720172429483 0.828428143962822 +260.51 13.7709210216143 3.1572027934724 0.843178501769848 +264.23 13.7718208450204 3.15720386186797 0.848028734656938 +280.69 13.7727206687324 3.15720492948155 0.827631727607347 +306.58 13.77362049275 3.15720599631313 0.827981917863001 +301.9 13.7745203170732 3.15720706236272 0.830031979507553 +314.25 13.7754201417016 3.15720812763031 0.801646028825691 +307.9 13.776319966635 3.1572091921159 0.802070859621216 +307.76 13.7772197918732 3.15721025581949 0.801633072574659 +289.01 13.778119617416 3.15721131874108 0.808980828089108 +277.3 13.7790194432631 3.15721238088066 0.814223521520685 +250.58 13.7799192694144 3.15721344223825 0.828523381068717 +237.17 13.7808190958695 3.15721450281382 0.832880861106943 +229.01 13.7817189226284 3.15721556260739 0.812120061526302 +236.31 13.7826187496907 3.15721662161895 0.820008518715019 +231.03 13.7835185770562 3.15721767984851 0.827455823880565 +232.55 13.7844184047247 3.15721873729605 0.819033483778151 +235.67 13.7853182326961 3.15721979396158 0.819527933435218 +244.94 13.7862180609699 3.1572208498451 0.806913804015264 +242.15 13.7871178895461 3.1572219049466 0.802721887008037 +240.41 13.7880177184245 3.15722295926609 0.80732583748696 +237.53 13.7889175476047 3.15722401280355 0.813324009288573 +226.97 13.7898173770865 3.15722506555901 0.819122240213646 +233.78 13.7907172068698 3.15722611753244 0.821882067759876 +239.87 13.7916170369543 3.15722716872385 0.819444913331008 +243.47 13.7925168673398 3.15722821913324 0.805564846960941 +255.63 13.7934166980261 3.1572292687606 0.784873411814897 +249.39 13.7943165290129 3.15723031760594 0.816739216188347 +236.84 13.7952163603001 3.15723136566925 0.811210431579068 +233.41 13.7961161918873 3.15723241295054 0.81754377917178 +240.29 13.7970160237744 3.15723345944979 0.808294285769837 +233.87 13.7979158559611 3.15723450516702 0.814972916468688 +236.67 13.7988156884473 3.15723555010222 0.806968178441012 +237.09 13.7997155212327 3.15723659425538 0.807356857120988 +241.02 13.800615354317 3.15723763762651 0.799121309273749 +242.08 13.711534478873 3.15622607690368 0.83727117064535 +233.13 13.7124342808155 3.15622719658638 0.811638926571693 +226.04 13.7133340830787 3.1562283154874 0.804995543394897 +231.66 13.7142338856624 3.15622943360674 0.802945702003458 +227.96 13.7151336885663 3.15623055094439 0.823662094943202 +221.39 13.7160334917902 3.15623166750036 0.830737917606746 +228.44 13.716933295334 3.15623278327465 0.827838881628218 +228.49 13.7178330991973 3.15623389826725 0.822949740643921 +229.63 13.71873290338 3.15623501247816 0.820146261619089 +233.52 13.7196327078818 3.15623612590738 0.809338412301678 +241.86 13.7205325127025 3.15623723855491 0.81476143403687 +239.15 13.7214323178419 3.15623835042075 0.819360495834941 +232.46 13.7223321232998 3.15623946150489 0.827687371415415 +230.16 13.7232319290759 3.15624057180734 0.820722979302812 +226.99 13.72413173517 3.15624168132809 0.815242864939485 +230.48 13.7250315415819 3.15624279006714 0.817345694543906 +229.75 13.7259313483113 3.15624389802449 0.814104199215636 +231.71 13.7268311553581 3.15624500520015 0.830493257176226 +232.81 13.7277309627221 3.1562461115941 0.833667669082168 +229.68 13.7286307704029 3.15624721720634 0.834595483067676 +235.55 13.7295305784003 3.15624832203689 0.831267602662419 +236.45 13.7304303867143 3.15624942608572 0.850955175427644 +232.91 13.7313301953444 3.15625052935285 0.825865942042528 +230.61 13.7322300042905 3.15625163183827 0.820921432838962 +232.43 13.7331298135524 3.15625273354198 0.81802169347615 +234.66 13.7340296231299 3.15625383446398 0.82787421119793 +228.28 13.7349294330227 3.15625493460426 0.825289794681415 +231.81 13.7358292432306 3.15625603396283 0.825072106522478 +234.99 13.7367290537533 3.15625713253969 0.823813612352111 +229.45 13.7376288645907 3.15625823033483 0.823710662850324 +233.81 13.7385286757426 3.15625932734825 0.817826300717961 +237.93 13.7394284872086 3.15626042357995 0.816203360260649 +250.59 13.7403282989886 3.15626151902993 0.824692783617859 +249.79 13.7412281110824 3.15626261369818 0.818277999804343 +231.38 13.7421279234897 3.15626370758471 0.82940200716276 +234.05 13.7430277362103 3.15626480068952 0.818140690445581 +234.96 13.743927549244 3.1562658930126 0.819619681411665 +232.31 13.7448273625906 3.15626698455396 0.823428337047014 +236.86 13.7457271762498 3.15626807531358 0.847733708856254 +235.41 13.7466269902214 3.15626916529147 0.816042888352305 +234.4 13.7475268045052 3.15627025448763 0.825042198219344 +239.82 13.748426619101 3.15627134290206 0.822865187700927 +250.13 13.7493264340085 3.15627243053476 0.838652912048303 +248 13.7502262492275 3.15627351738571 0.823800603093465 +253.46 13.7511260647578 3.15627460345493 0.808243334238595 +246.48 13.7520258805992 3.15627568874242 0.811304546351581 +248.66 13.7529256967514 3.15627677324816 0.798888295700782 +231.58 13.7538255132143 3.15627785697216 0.821413113433723 +247.24 13.7547253299875 3.15627893991442 0.817436645235412 +250.88 13.7556251470709 3.15628002207493 0.815667637368784 +236.96 13.7565249644643 3.1562811034537 0.821854167895699 +239.41 13.7574247821674 3.15628218405072 0.82559602565443 +239.25 13.75832460018 3.156283263866 0.818785808931937 +244.68 13.7592244185018 3.15628434289952 0.816391202156658 +245.92 13.7601242371328 3.1562854211513 0.819472690561059 +249.55 13.7610240560725 3.15628649862132 0.806696218051495 +239.51 13.7619238753209 3.15628757530959 0.808980925047965 +228.01 13.7628236948776 3.1562886512161 0.818433877638196 +231.44 13.7637235147425 3.15628972634086 0.809315718294758 +233.85 13.7646233349153 3.15629080068386 0.808510302609574 +235.27 13.7655231553958 3.15629187424511 0.810567360523051 +242.22 13.7664229761839 3.15629294702459 0.80750813789671 +234.11 13.7673227972791 3.15629401902231 0.810056978921783 +234.77 13.7682226186814 3.15629509023827 0.81454152296923 +235.35 13.7691224403906 3.15629616067247 0.815545406365932 +243.69 13.7700222624063 3.1562972303249 0.822239199194625 +274.42 13.7709220847284 3.15629829919556 0.823496559101106 +278.31 13.7718219073566 3.15629936728446 0.831948975692914 +295.38 13.7727217302907 3.15630043459158 0.820091628390776 +283.37 13.7736215535306 3.15630150111694 0.824262619518825 +278.02 13.7745213770759 3.15630256686052 0.822952119548643 +291.84 13.7754212009264 3.15630363182234 0.802748772701498 +311.47 13.776321025082 3.15630469600237 0.798002292843395 +307.28 13.7772208495423 3.15630575940063 0.805040476183249 +290.99 13.7781206743073 3.15630682201712 0.790630094266071 +277.16 13.7790204993765 3.15630788385183 0.798937287483493 +268.07 13.7799203247499 3.15630894490475 0.824140987403521 +253.52 13.7808201504273 3.1563100051759 0.825285467070229 +241.77 13.7817199764082 3.15631106466526 0.829564101951767 +241.75 13.7826198026927 3.15631212337284 0.83328083084361 +232.67 13.7835196292803 3.15631318129864 0.818841283478391 +244.31 13.784419456171 3.15631423844265 0.823514001486884 +248.51 13.7853192833645 3.15631529480487 0.812838785215594 +241.9 13.7862191108605 3.1563163503853 0.812610511267447 +235.62 13.7871189386588 3.15631740518394 0.808593612209624 +242.61 13.7880187667593 3.15631845920079 0.817651583364015 +241.63 13.7889185951616 3.15631951243585 0.801855622727021 +240.12 13.7898184238656 3.15632056488912 0.807937357319669 +241.21 13.790718252871 3.15632161656059 0.814192022041207 +242.15 13.7916180821777 3.15632266745026 0.829225905643754 +245.4 13.7925179117853 3.15632371755813 0.795484549284975 +264.03 13.7934177416937 3.15632476688421 0.775788139655523 +244.83 13.7943175719027 3.15632581542848 0.806003195617439 +245.7 13.7952174024119 3.15632686319096 0.798722388151379 +243.68 13.7961172332213 3.15632791017163 0.800979315394472 +242.56 13.7970170643305 3.1563289563705 0.811534714696965 +237.22 13.7979168957394 3.15633000178756 0.806452883706272 +240.32 13.7988167274477 3.15633104642281 0.812686959103053 +250.52 13.7997165594551 3.15633209027626 0.802854728710242 +250.08 13.8006163917616 3.15633313334789 0.798578686507613 +241.06 13.7115355930007 3.15532160334756 0.799833521799221 +245.14 13.7124353941657 3.15532272270877 0.817708204298754 +230.68 13.7133351956513 3.15532384128852 0.810379288452042 +228.95 13.7142349974575 3.15532495908682 0.812811357213688 +228.51 13.7151347995839 3.15532607610366 0.818324053898317 +230.23 13.7160346020303 3.15532719233904 0.82365758528773 +234.81 13.7169344047965 3.15532830779296 0.816460173643293 +233.61 13.7178342078823 3.15532942246541 0.816210283292016 +226.41 13.7187340112874 3.15533053635641 0.82639801538666 +233.41 13.7196338150117 3.15533164946593 0.817081107726434 +239.57 13.7205336190549 3.15533276179399 0.815598228356749 +245.03 13.7214334234167 3.15533387334059 0.823130072929464 +233.36 13.722333228097 3.15533498410571 0.823053276422584 +236.28 13.7232330330956 3.15533609408936 0.824826858291283 +221.52 13.7241328384121 3.15533720329154 0.829140488936407 +233.81 13.7250326440465 3.15533831171225 0.825196639853829 +238.41 13.7259324499984 3.15533941935148 0.837742198245356 +235.88 13.7268322562677 3.15534052620923 0.839612906184787 +237.58 13.727732062854 3.15534163228551 0.835049789731251 +232.47 13.7286318697573 3.15534273758031 0.83151870027124 +232.48 13.7295316769772 3.15534384209363 0.838329327623625 +244.08 13.7304314845136 3.15534494582546 0.840200058952733 +235.43 13.7313312923661 3.15534604877582 0.837105021101612 +226.76 13.7322311005347 3.15534715094468 0.829702650172134 +232.05 13.7331309090191 3.15534825233207 0.828124093098845 +235.53 13.734030717819 3.15534935293796 0.82161461211438 +232.69 13.7349305269342 3.15535045276237 0.830563230299891 +225.64 13.7358303363645 3.15535155180529 0.831935047361299 +235.1 13.7367301461097 3.15535265006671 0.820760871591269 +227.06 13.7376299561695 3.15535374754665 0.834234604562819 +232.64 13.7385297665438 3.15535484424508 0.81142522698744 +237.87 13.7394295772323 3.15535594016203 0.814190009045248 +244.27 13.7403293882347 3.15535703529748 0.817363625597945 +241.56 13.7412291995509 3.15535812965143 0.81774794817064 +226.71 13.7421290111807 3.15535922322388 0.813758698280763 +225.64 13.7430288231237 3.15536031601483 0.810864111186562 +225.59 13.7439286353798 3.15536140802427 0.800989738426273 +238.26 13.7448284479488 3.15536249925222 0.809147907833814 +232.68 13.7457282608305 3.15536358969866 0.826117641067057 +232.31 13.7466280740245 3.15536467936359 0.830838084641198 +235.33 13.7475278875307 3.15536576824702 0.820036324010171 +233.27 13.7484277013489 3.15536685634893 0.830342325110405 +250 13.7493275154788 3.15536794366934 0.836141375209093 +250.6 13.7502273299202 3.15536903020824 0.826823276053007 +258.4 13.751127144673 3.15537011596562 0.798697538175283 +248.3 13.7520269597368 3.15537120094149 0.805825979406476 +243.17 13.7529267751114 3.15537228513584 0.810682501759025 +230.24 13.7538265907967 3.15537336854868 0.824988094300639 +239.98 13.7547264067923 3.15537445117999 0.817161514890072 +238.3 13.7556262230981 3.15537553302979 0.82787255880052 +237.43 13.7565260397139 3.15537661409807 0.810348053892216 +241.25 13.7574258566394 3.15537769438483 0.828509252229527 +248.88 13.7583256738744 3.15537877389006 0.813957379935539 +247.05 13.7592254914186 3.15537985261377 0.821395790585342 +246.06 13.760125309272 3.15538093055595 0.812159940209268 +245.77 13.7610251274341 3.1553820077166 0.814329401485365 +243.15 13.7619249459049 3.15538308409573 0.824451007631789 +238.25 13.762824764684 3.15538415969332 0.819764214826492 +234.89 13.7637245837713 3.15538523450938 0.809920544299113 +237.19 13.7646244031665 3.15538630854391 0.809691325549073 +241.97 13.7655242228694 3.15538738179691 0.811104451923225 +252.38 13.7664240428798 3.15538845426837 0.813474355259345 +240.38 13.7673238631975 3.1553895259583 0.81810495125072 +238.12 13.7682236838222 3.15539059686668 0.815503257545539 +242.78 13.7691235047537 3.15539166699353 0.821799776179992 +244.42 13.7700233259918 3.15539273633884 0.81503413140126 +243.67 13.7709231475363 3.1553938049026 0.809334512881199 +257.49 13.7718229693869 3.15539487268482 0.817233503886125 +266.5 13.7727227915434 3.1553959396855 0.819434094045857 +268.8 13.7736226140056 3.15539700590463 0.810420968010398 +258.93 13.7745224367733 3.15539807134221 0.814788653593309 +272.28 13.7754222598462 3.15539913599824 0.819164772672938 +300.78 13.7763220832241 3.15540019987273 0.796599937059658 +298.13 13.7772219069069 3.15540126296566 0.796703545402228 +283.65 13.7781217308942 3.15540232527704 0.807105402698403 +274.39 13.7790215551858 3.15540338680687 0.794391258993958 +263.76 13.7799213797816 3.15540444755514 0.807439180806998 +268.07 13.7808212046813 3.15540550752186 0.813698114602339 +280.32 13.7817210298846 3.15540656670701 0.800265322703499 +256.19 13.7826208553914 3.15540762511061 0.813628970416806 +260.33 13.7835206812015 3.15540868273265 0.812735813266932 +246.37 13.7844205073145 3.15540973957313 0.808453512478617 +243.75 13.7853203337303 3.15541079563204 0.811889275000743 +240.59 13.7862201604487 3.15541185090939 0.813684147112865 +233.39 13.7871199874694 3.15541290540517 0.823918035939093 +241 13.7880198147922 3.15541395911939 0.81022328452136 +239.4 13.7889196424169 3.15541501205204 0.810604560478896 +232.47 13.7898194703433 3.15541606420312 0.817400435739618 +241.92 13.7907192985711 3.15541711557262 0.81691030696499 +242.4 13.7916191271001 3.15541816616056 0.8183209655789 +255.07 13.79251895593 3.15541921596692 0.77957694408424 +237.18 13.7934187850608 3.15542026499171 0.789815697046289 +241.49 13.7943186144921 3.15542131323492 0.801607524912781 +236.01 13.7952184442237 3.15542236069656 0.809240739621729 +250.5 13.7961182742554 3.15542340737661 0.798562668554985 +243.69 13.797018104587 3.15542445327509 0.793583707261581 +246.7 13.7979179352182 3.15542549839198 0.796397330951833 +264.79 13.7988177661488 3.1554265427273 0.785933473358061 +264.13 13.7997175973786 3.15542758628103 0.79426134849427 +249.01 13.8006174289074 3.15542862905317 0.802138565203202 +242.82 13.7115367068075 3.15441712977528 0.809442203281871 +252.32 13.7124365071952 3.154418248815 0.819630889233493 +228.58 13.7133363079035 3.15441936707349 0.819906288644589 +233.58 13.7142361089323 3.15442048455075 0.821032348908734 +227.95 13.7151359102814 3.15442160124678 0.820373792142489 +237.95 13.7160357119505 3.15442271716156 0.806038906422415 +233.02 13.7169355139394 3.15442383229512 0.81611953487132 +242.35 13.7178353162479 3.15442494664743 0.814397665601892 +225.83 13.7187351188757 3.15442606021851 0.820386888319051 +240.04 13.7196349218227 3.15442717300834 0.823474032179287 +244.22 13.7205347250885 3.15442828501693 0.825463616647806 +238.46 13.7214345286731 3.15442939624428 0.82177488821614 +235.65 13.7223343325761 3.15443050669038 0.814922582882299 +232.28 13.7232341367973 3.15443161635524 0.818325553380515 +232.01 13.7241339413365 3.15443272523885 0.812843088058635 +243.02 13.7250337461936 3.15443383334121 0.817746578158961 +234.59 13.7259335513681 3.15443494066232 0.825405039608296 +229.13 13.7268333568601 3.15443604720217 0.824870367096812 +227.34 13.7277331626691 3.15443715296078 0.830629247185287 +226.56 13.728632968795 3.15443825793813 0.827096162955945 +229.8 13.7295327752376 3.15443936213422 0.82637946857872 +233.9 13.7304325819967 3.15444046554906 0.839333248402519 +230.49 13.7313323890719 3.15444156818264 0.831655795841237 +234.44 13.7322321964631 3.15444267003496 0.824568371118098 +233.14 13.7331320041702 3.15444377110601 0.83725597767381 +233.13 13.7340318121927 3.1544448713958 0.832318346630537 +232.2 13.7349316205306 3.15444597090434 0.833508122486682 +229.85 13.7358314291836 3.1544470696316 0.832111646188806 +246.72 13.7367312381514 3.1544481675776 0.8180897935404 +239.54 13.7376310474339 3.15444926474233 0.823471854495223 +232.78 13.7385308570309 3.15445036112579 0.825944014468665 +237.41 13.739430666942 3.15445145672797 0.824556742998891 +246.67 13.7403304771671 3.15445255154889 0.827298184129602 +239.04 13.7412302877059 3.15445364558853 0.817286520977188 +233.09 13.7421300985583 3.1544547388469 0.813389173355296 +226.33 13.743029909724 3.154455831324 0.815287694574389 +225.76 13.7439297212028 3.15445692301981 0.819620881495295 +239.07 13.7448295329944 3.15445801393435 0.815960245542239 +237.75 13.7457293450987 3.1544591040676 0.821555594425981 +230.57 13.7466291575154 3.15446019341957 0.828202797825893 +232.45 13.7475289702442 3.15446128199027 0.843849461527469 +232.73 13.748428783285 3.15446236977967 0.84036036766146 +238.34 13.7493285966376 3.15446345678779 0.824549383750847 +248.46 13.7502284103017 3.15446454301463 0.826880592068928 +244.93 13.751128224277 3.15446562846017 0.822846991048174 +238.9 13.7520280385635 3.15446671312443 0.817420602779041 +236.6 13.7529278531607 3.15446779700739 0.824486273069507 +230.74 13.7538276680686 3.15446888010906 0.812297507514883 +239.94 13.7547274832869 3.15446996242944 0.820665914803594 +244.86 13.7556272988154 3.15447104396853 0.821869148191032 +235.22 13.7565271146538 3.15447212472631 0.813363496176155 +242.76 13.7574269308019 3.1544732047028 0.822726774958934 +246.46 13.7583267472595 3.15447428389799 0.81556937122425 +247.8 13.7592265640264 3.15447536231188 0.811078966125792 +246.2 13.7601263811023 3.15447643994447 0.829170214614649 +239.97 13.7610261984871 3.15447751679576 0.818361399450194 +238.52 13.7619260161805 3.15447859286574 0.825013551114805 +238.83 13.7628258341822 3.15447966815441 0.818846707152348 +237.23 13.7637256524921 3.15448074266178 0.828201089548141 +242.93 13.76462547111 3.15448181638784 0.813166563877315 +249.49 13.7655252900355 3.15448288933259 0.803629389761757 +254.13 13.7664251092685 3.15448396149603 0.809157172585864 +244.46 13.7673249288088 3.15448503287816 0.817229620301997 +240.07 13.7682247486561 3.15448610347898 0.822981123208271 +239.01 13.7691245688102 3.15448717329847 0.821168155316642 +245.01 13.770024389271 3.15448824233666 0.824868802465544 +252.54 13.770924210038 3.15448931059352 0.823805716224121 +257.56 13.7718240311112 3.15449037806907 0.808075201303335 +260.21 13.7727238524904 3.15449144476329 0.811032632990612 +271.52 13.7736236741752 3.1544925106762 0.810678526506141 +258.53 13.7745234961655 3.15449357580778 0.818033942037013 +264.85 13.775423318461 3.15449464015804 0.816015381699028 +281.9 13.7763231410615 3.15449570372697 0.804390663228196 +290.68 13.7772229639668 3.15449676651457 0.806976766614908 +273.83 13.7781227871768 3.15449782852085 0.796062855544818 +269.03 13.779022610691 3.1544988897458 0.804517765976025 +260.25 13.7799224345094 3.15449995018942 0.809039152261848 +287.68 13.7808222586317 3.1545010098517 0.765420929906602 +287.76 13.7817220830576 3.15450206873265 0.745284279103542 +290.28 13.782621907787 3.15450312683227 0.756666235246209 +304.78 13.7835217328196 3.15450418415055 0.755274990322485 +270.49 13.7844215581552 3.1545052406875 0.802846120369492 +256.29 13.7853213837936 3.1545062964431 0.826009192039528 +242.48 13.7862212097346 3.15450735141737 0.819325101007227 +241.24 13.7871210359779 3.15450840561029 0.817307621940064 +251.87 13.7880208625233 3.15450945902187 0.806757379904993 +246.54 13.7889206893706 3.15451051165211 0.803531088436406 +240.15 13.7898205165195 3.15451156350101 0.821696501250339 +237.34 13.7907203439699 3.15451261456855 0.829377990096207 +245.21 13.7916201717214 3.15451366485475 0.809100314790763 +246.67 13.792519999774 3.1545147143596 0.782018533161824 +229.31 13.7934198281273 3.1545157630831 0.815600960175402 +237.04 13.7943196567812 3.15451681102525 0.802078654537927 +228.94 13.7952194857354 3.15451785818605 0.816430404240104 +247.82 13.7961193149896 3.15451890456549 0.794742500058004 +242.62 13.7970191445438 3.15451995016358 0.812511514827485 +250.47 13.7979189743976 3.15452099498031 0.811630152673126 +251.41 13.7988188045508 3.15452203901568 0.794266545616816 +253.68 13.7997186350032 3.15452308226969 0.78816700299885 +258.04 13.8006184657545 3.15452412474235 0.802262330655093 +240.65 13.7115378202934 3.15351265618685 0.820045509644217 +249.42 13.7124376199039 3.15351377490509 0.814362346671958 +229.83 13.7133374198352 3.15351489284232 0.820450651655143 +227.11 13.7142372200869 3.15351600999854 0.803707652508823 +235.29 13.7151370206589 3.15351712637375 0.810132605304212 +228.26 13.7160368215509 3.15351824196794 0.811281396670221 +233.33 13.7169366227628 3.15351935678113 0.81335466691765 +235.24 13.7178364242941 3.1535204708133 0.803860068505788 +241.77 13.7187362261449 3.15352158406446 0.814269511207129 +244.9 13.7196360283147 3.1535226965346 0.826553172295254 +246.12 13.7205358308035 3.15352380822373 0.809923576559655 +241.37 13.721435633611 3.15352491913183 0.815871620136294 +245.4 13.7223354367369 3.15352602925891 0.818315338065102 +244.26 13.723235240181 3.15352713860498 0.830241556068115 +239.4 13.7241350439431 3.15352824717002 0.825371186739552 +245.96 13.7250348480231 3.15352935495403 0.816979575067912 +232.68 13.7259346524205 3.15353046195702 0.825317162576248 +231.55 13.7268344571354 3.15353156817898 0.835981784816149 +233.14 13.7277342621673 3.15353267361991 0.825061016551739 +231.94 13.7286340675161 3.15353377827981 0.831623982745821 +231.47 13.7295338731816 3.15353488215868 0.827035334801306 +239.08 13.7304336791635 3.15353598525652 0.846141660937584 +246.17 13.7313334854617 3.15353708757332 0.844111987087963 +236.17 13.7322332920758 3.15353818910909 0.836770283249254 +236.99 13.7331330990057 3.15353928986382 0.839264235827303 +226.9 13.7340329062511 3.15354038983751 0.826735369276528 +229.32 13.7349327138119 3.15354148903017 0.823165102467212 +231.35 13.7358325216878 3.15354258744178 0.823515009059302 +239.25 13.7367323298785 3.15354368507235 0.823916689613738 +243.18 13.7376321383839 3.15354478192187 0.809101220318694 +230.54 13.7385319472037 3.15354587799035 0.817848615272307 +235.24 13.7394317563377 3.15354697327779 0.822595277904823 +235 13.7403315657857 3.15354806778417 0.82416732895022 +232.49 13.7412313755474 3.15354916150951 0.813811793875069 +234.61 13.7421311856227 3.1535502544538 0.813895296555499 +219.62 13.7430309960112 3.15355134661703 0.825736065674958 +232.96 13.7439308067129 3.15355243799922 0.821060780047914 +246.49 13.7448306177274 3.15355352860034 0.806320998762794 +246.95 13.7457304290545 3.15355461842042 0.827697570300317 +230.76 13.7466302406941 3.15355570745943 0.837798923891052 +238.08 13.7475300526458 3.15355679571739 0.836752264974268 +246.99 13.7484298649095 3.15355788319428 0.855005996698151 +246.19 13.7493296774849 3.15355896989012 0.830227415255636 +249.52 13.7502294903718 3.15356005580489 0.84187087946262 +248.46 13.7511293035701 3.1535611409386 0.823027904879421 +237.44 13.7520291170793 3.15356222529124 0.827625173540733 +239.84 13.7529289308995 3.15356330886282 0.819067336787642 +240.4 13.7538287450302 3.15356439165333 0.820445270933416 +235.42 13.7547285594714 3.15356547366277 0.826579265444137 +236.62 13.7556283742227 3.15356655489114 0.816622631539216 +236.91 13.7565281892839 3.15356763533843 0.811093450643743 +236.08 13.7574280046549 3.15356871500466 0.819574817393419 +241.46 13.7583278203354 3.15356979388981 0.82162874563703 +242.34 13.7592276363251 3.15357087199388 0.818129321813371 +239.62 13.7601274526239 3.15357194931688 0.831028529606427 +234.74 13.7610272692315 3.1535730258588 0.8267084938252 +231.9 13.7619270861477 3.15357410161963 0.834735673437467 +247.13 13.7628269033723 3.15357517659939 0.829530306062569 +242.91 13.7637267209051 3.15357625079807 0.826851828872683 +245.51 13.7646265387457 3.15357732421566 0.808469798759153 +259.57 13.7655263568941 3.15357839685216 0.810376706504709 +270.13 13.76642617535 3.15357946870758 0.805728320198072 +262.67 13.7673259941131 3.15358053978191 0.826112120383917 +251.28 13.7682258131832 3.15358161007515 0.831301300741919 +242.94 13.7691256325602 3.1535826795873 0.822301985783595 +264.81 13.7700254522437 3.15358374831836 0.814855033119774 +258.69 13.7709252722336 3.15358481626833 0.827389755526692 +261.89 13.7718250925297 3.1535858834372 0.828601807549176 +271.49 13.7727249131316 3.15358694982498 0.822582543980502 +275.43 13.7736247340393 3.15358801543166 0.80911054375506 +261.29 13.7745245552524 3.15358908025724 0.828138087153367 +269.47 13.7754243767707 3.15359014430172 0.809461847169527 +277.04 13.7763241985941 3.1535912075651 0.798595287056077 +281.76 13.7772240207223 3.15359227004738 0.801817629199635 +272.65 13.778123843155 3.15359333174855 0.807091794077425 +296.23 13.7790236658921 3.15359439266862 0.717851834358981 +289.33 13.7799234889332 3.15359545280758 0.741616574831636 +281.13 13.7808233122783 3.15359651216544 0.781338838723295 +266.92 13.7817231359271 3.15359757074219 0.799973142438047 +290.93 13.7826229598793 3.15359862853782 0.766434072740678 +303.74 13.7835227841347 3.15359968555235 0.774551476676787 +303.62 13.7844226086932 3.15360074178576 0.751315954567453 +280.47 13.7853224335544 3.15360179723806 0.792066480959866 +266.08 13.7862222587182 3.15360285190924 0.808179952384862 +247.65 13.7871220841843 3.15360390579931 0.806924767364727 +250.05 13.7880219099525 3.15360495890826 0.810298122902646 +256.1 13.7889217360225 3.15360601123609 0.806620794598767 +247.35 13.7898215623943 3.15360706278279 0.815758548746931 +248.54 13.7907213890674 3.15360811354838 0.809026089474016 +248.86 13.7916212160418 3.15360916353284 0.794660638746348 +232.02 13.7925210433172 3.15361021273618 0.848168163030894 +225.16 13.7934208708933 3.1536112611584 0.829412551079766 +224.9 13.79432069877 3.15361230879948 0.815066039499097 +226.32 13.795220526947 3.15361335565944 0.821525033189385 +236.46 13.796120355424 3.15361440173827 0.805100713469195 +237.2 13.797020184201 3.15361544703597 0.808018513161701 +243.41 13.7979200132775 3.15361649155253 0.820490273875651 +251.47 13.7988198426535 3.15361753528796 0.810012227839323 +256.44 13.7997196723287 3.15361857824226 0.808247994974654 +259.61 13.8006195023029 3.15361962041542 0.806556867057585 +245.06 13.7115389334583 3.15260818258229 0.804262864041044 +236.84 13.712438732292 3.15260930097903 0.814048888237747 +232.93 13.7133385314464 3.152610418595 0.802905984935741 +232.31 13.7142383309213 3.15261153543018 0.804915344208783 +237.74 13.7151381307164 3.15261265148457 0.811860256429755 +231.49 13.7160379308316 3.15261376675818 0.814374062599645 +241 13.7169377312665 3.152614881251 0.798632482632998 +239.46 13.7178375320211 3.15261599496304 0.798429206573046 +246.54 13.7187373330949 3.15261710789428 0.80863385659737 +236.12 13.7196371344879 3.15261822004473 0.825378633404115 +244.35 13.7205369361998 3.15261933141438 0.811555419629431 +237.89 13.7214367382304 3.15262044200324 0.811972348433728 +246.22 13.7223365405794 3.15262155181131 0.802841150526763 +245.6 13.7232363432467 3.15262266083858 0.817936624442049 +240.8 13.724136146232 3.15262376908505 0.820914550513714 +239.94 13.725035949535 3.15262487655072 0.817645053422601 +234.01 13.7259357531556 3.15262598323558 0.824345080486232 +236.37 13.7268355570936 3.15262708913965 0.823828430703839 +230.88 13.7277353613486 3.15262819426291 0.832060799243186 +238.43 13.7286351659205 3.15262929860536 0.843274459117014 +230.52 13.7295349708091 3.15263040216701 0.830895189505412 +243.41 13.7304347760142 3.15263150494785 0.839640964234465 +239.34 13.7313345815354 3.15263260694788 0.816286706616475 +244.98 13.7322343873727 3.15263370816709 0.815293107632789 +241.1 13.7331341935257 3.1526348086055 0.829332513846304 +234.86 13.7340339999943 3.15263590826309 0.826539349468368 +227.18 13.7349338067781 3.15263700713987 0.831502552163601 +235.23 13.7358336138771 3.15263810523583 0.817974704622348 +239.02 13.7367334212909 3.15263920255097 0.814391289802622 +244.52 13.7376332290194 3.15264029908529 0.810673757319501 +232.12 13.7385330370623 3.15264139483879 0.818888535567984 +233.83 13.7394328454194 3.15264248981147 0.825263395901636 +232.74 13.7403326540905 3.15264358400333 0.819129709966469 +236.18 13.7412324630754 3.15264467741436 0.807644961967657 +234.98 13.7421322723737 3.15264577004457 0.813600431537975 +226.29 13.7430320819854 3.15264686189395 0.826703626871474 +230.78 13.7439318919101 3.1526479529625 0.81113404542498 +259.1 13.7448317021477 3.15264904325022 0.805923677057224 +241.43 13.7457315126979 3.15265013275711 0.818638634796762 +241.57 13.7466313235606 3.15265122148316 0.833910548828554 +247.88 13.7475311347354 3.15265230942839 0.826507664279851 +246.27 13.7484309462222 3.15265339659277 0.826995047245559 +247.96 13.7493307580207 3.15265448297632 0.835371053053374 +252.55 13.7502305701307 3.15265556857904 0.848692756536217 +245 13.751130382552 3.15265665340091 0.819359181672508 +238.21 13.7520301952844 3.15265773744194 0.809210038371907 +237.22 13.7529300083276 3.15265882070213 0.814675206134974 +244.15 13.7538298216814 3.15265990318147 0.80994536063132 +243.25 13.7547296353456 3.15266098487998 0.814856763387504 +236.16 13.75562944932 3.15266206579763 0.826173592838192 +239.81 13.7565292636044 3.15266314593444 0.804154205281576 +240.36 13.7574290781984 3.1526642252904 0.819852066566385 +234.1 13.7583288931019 3.15266530386551 0.83036409205481 +240.85 13.7592287083148 3.15266638165976 0.819206748610633 +241.94 13.7601285238366 3.15266745867317 0.819926959453132 +240.25 13.7610283396673 3.15266853490572 0.823962223101971 +234.95 13.7619281558066 3.15266961035742 0.822802648453577 +238.78 13.7628279722543 3.15267068502825 0.823321453413744 +246.98 13.7637277890101 3.15267175891823 0.817567067666948 +247.88 13.7646276060738 3.15267283202735 0.818625092691396 +271.59 13.7655274234452 3.15267390435561 0.811773837042536 +286.33 13.7664272411242 3.15267497590301 0.79608841645012 +278.62 13.7673270591103 3.15267604666955 0.829142895340287 +268.99 13.7682268774036 3.15267711665522 0.82935198430356 +265.98 13.7691266960036 3.15267818586002 0.829259185652255 +286.4 13.7700265149102 3.15267925428396 0.816468866613009 +283.72 13.7709263341231 3.15268032192703 0.816329581866313 +274.78 13.7718261536422 3.15268138878923 0.817600222964028 +277.94 13.7727259734672 3.15268245487055 0.804232804232804 +277.59 13.7736257935979 3.15268352017101 0.827673482765528 +260 13.7745256140341 3.15268458469059 0.824266022639525 +253.59 13.7754254347755 3.15268564842929 0.825922579101939 +263.59 13.7763252558219 3.15268671138712 0.803118444823829 +277.73 13.7772250771731 3.15268777356407 0.807993957487539 +280.12 13.7781248988289 3.15268883496014 0.763753504024192 +260.73 13.779024720789 3.15268989557534 0.777212999120109 +262.36 13.7799245430532 3.15269095540965 0.813700430397214 +272.1 13.7808243656213 3.15269201446307 0.809228542367577 +272.09 13.7817241884931 3.15269307273562 0.813846686169042 +284.17 13.7826240116684 3.15269413022727 0.803795749195505 +271.35 13.7835238351469 3.15269518693804 0.808304420964096 +276.34 13.7844236589283 3.15269624286792 0.809392167741563 +274.28 13.7853234830126 3.15269729801691 0.795294315854955 +305.02 13.7862233073994 3.15269835238502 0.700334334061135 +279.94 13.7871231320885 3.15269940597222 0.77860041924981 +275.96 13.7880229570798 3.15270045877854 0.749304834213222 +256.6 13.7889227823729 3.15270151080396 0.808899304241507 +246.66 13.7898226079676 3.15270256204848 0.794147175289898 +245.34 13.7907224338638 3.15270361251211 0.795454114613941 +242.05 13.7916222600612 3.15270466219484 0.813350501241608 +226.3 13.7925220865596 3.15270571109667 0.827694722788691 +222.19 13.7934219133588 3.15270675921759 0.818956487497539 +218.72 13.7943217404585 3.15270780655762 0.81655128392036 +227.15 13.7952215678585 3.15270885311674 0.816345299277406 +236.5 13.7961213955585 3.15270989889495 0.824883327794715 +233.76 13.7970212235585 3.15271094389226 0.822914519596007 +244.23 13.7979210518581 3.15271198810866 0.823804264126356 +257.5 13.7988208804571 3.15271303154416 0.794420050514863 +259.58 13.7997207093553 3.15271407419874 0.793066213297799 +252.38 13.8006205385525 3.15271511607241 0.790197119740089 +248.58 13.7115400463023 3.15170370896158 0.804171064604186 +236.12 13.7124398443594 3.15170482703684 0.803119056675542 +232.34 13.7133396427372 3.15170594433154 0.800242878399158 +233.35 13.7142394414354 3.15170706084568 0.800446030677258 +243.19 13.7151392404539 3.15170817657926 0.800145861943222 +239.19 13.7160390397924 3.15170929153228 0.813114754098361 +239.71 13.7169388394507 3.15171040570474 0.811253219580956 +240.35 13.7178386394286 3.15171151909663 0.805258265936973 +247.32 13.7187384397258 3.15171263170796 0.803789763009105 +242.41 13.7196382403422 3.15171374353872 0.806294282668038 +238.91 13.7205380412774 3.15171485458891 0.823884079499154 +241.1 13.7214378425314 3.15171596485852 0.811725387441622 +244.82 13.7223376441038 3.15171707434757 0.811211919186063 +244.31 13.7232374459944 3.15171818305605 0.804177970494644 +241.82 13.724137248203 3.15171929098395 0.826700755115014 +228.72 13.7250370507294 3.15172039813127 0.830266902081431 +238 13.7259368535733 3.15172150449802 0.814156077135977 +236.68 13.7268366567346 3.15172261008419 0.804921651109273 +232.59 13.727736460213 3.15172371488977 0.826074667806891 +232.84 13.7286362640083 3.15172481891478 0.82976280188036 +228.94 13.7295360681203 3.15172592215921 0.828056568182396 +240.4 13.7304358725486 3.15172702462305 0.84600556732522 +237.55 13.7313356772932 3.1517281263063 0.823317753272903 +235.84 13.7322354823538 3.15172922720897 0.821949731307295 +235.22 13.7331352877302 3.15173032733105 0.81497749621712 +230.78 13.734035093422 3.15173142667254 0.818564198168078 +229.68 13.7349348994293 3.15173252523344 0.81282856037303 +241.5 13.7358347057516 3.15173362301375 0.814438524915587 +239.71 13.7367345123887 3.15173472001347 0.817272213295245 +246.56 13.7376343193405 3.15173581623259 0.811259692588383 +232.52 13.7385341266068 3.15173691167111 0.819110423457662 +243.26 13.7394339341872 3.15173800632904 0.808376706124391 +237.6 13.7403337420816 3.15173910020637 0.821516215779342 +247.9 13.7412335502898 3.15174019330309 0.81693273581908 +245.83 13.7421333588114 3.15174128561922 0.817219446706429 +245.44 13.7430331676464 3.15174237715474 0.804037483838241 +242.03 13.7439329767945 3.15174346790966 0.810931103335701 +246.58 13.7448327862554 3.15174455788397 0.817384033787598 +238.74 13.745732596029 3.15174564707768 0.828235767898183 +234.43 13.7466324061149 3.15174673549078 0.826371660388698 +240.98 13.747532216513 3.15174782312327 0.819316593917916 +244.83 13.7484320272231 3.15174890997515 0.824421572107015 +252.62 13.7493318382449 3.15174999604641 0.821515171040896 +257.03 13.7502316495783 3.15175108133706 0.822659279778393 +246.5 13.7511314612229 3.1517521658471 0.813240615908607 +238.12 13.7520312731786 3.15175324957652 0.821683486004904 +231.92 13.7529310854451 3.15175433252532 0.820965476510474 +236.64 13.7538308980222 3.15175541469351 0.812914906457453 +245.38 13.7547307109097 3.15175649608107 0.814328885444187 +241.17 13.7556305241074 3.15175757668801 0.809353573202643 +236.79 13.7565303376151 3.15175865651433 0.816872435778444 +238.44 13.7574301514324 3.15175973556002 0.820803127194628 +239.15 13.7583299655593 3.15176081382509 0.817578346501342 +251.54 13.7592297799954 3.15176189130953 0.80062068913187 +236.84 13.7601295947405 3.15176296801335 0.81293980206221 +233.67 13.7610294097945 3.15176404393653 0.822961596756816 +237.45 13.7619292251571 3.15176511907908 0.821176015445107 +242.46 13.762829040828 3.15176619344101 0.81549022864419 +243.76 13.7637288568071 3.15176726702229 0.823428769361571 +261.69 13.7646286730942 3.15176833982295 0.82044196119022 +282.14 13.7655284896889 3.15176941184296 0.804189310610894 +304.61 13.7664283065911 3.15177048308234 0.78298504373657 +279.48 13.7673281238006 3.15177155354108 0.811459460812223 +275.61 13.7682279413171 3.15177262321918 0.822485458328026 +282.64 13.7691277591404 3.15177369211664 0.811958850613138 +280.98 13.7700275772702 3.15177476023345 0.816841794423801 +277.41 13.7709273957065 3.15177582756962 0.815278147458078 +268.66 13.7718272144488 3.15177689412515 0.819070493108649 +287.99 13.7727270334971 3.15177795990002 0.788673270360947 +296.28 13.7736268528511 3.15177902489425 0.797458811703916 +267.66 13.7745266725105 3.15178008910783 0.804301653633442 +264.97 13.7754264924752 3.15178115254077 0.813389174524909 +257.57 13.7763263127449 3.15178221519304 0.820575849638529 +279.85 13.7772261333194 3.15178327706467 0.799833347549094 +279.21 13.7781259541984 3.15178433815564 0.747337644244861 +263.25 13.7790257753818 3.15178539846595 0.803425697308683 +270.11 13.7799255968693 3.15178645799561 0.811169309936771 +271.88 13.7808254186607 3.15178751674461 0.823315785366556 +260.1 13.7817252407558 3.15178857471294 0.81744966442953 +267.58 13.7826250631543 3.15178963190062 0.793290070228465 +266.75 13.783524885856 3.15179068830764 0.801086380403889 +267.39 13.7844247088607 3.15179174393399 0.802304385210662 +269.63 13.7853245321682 3.15179279877967 0.808676263109603 +270.04 13.7862243557783 3.15179385284469 0.812814799187785 +287.23 13.7871241796907 3.15179490612904 0.799391228641496 +283.52 13.7880240039052 3.15179595863272 0.766533520696637 +261.71 13.7889238284215 3.15179701035574 0.791780618311534 +246.54 13.7898236532396 3.15179806129808 0.81096389658707 +246.3 13.790723478359 3.15179911145975 0.806105859896489 +237.61 13.7916233037797 3.15180016084074 0.817443786531615 +226.89 13.7925231295013 3.15180120944106 0.820692424546636 +226.76 13.7934229555237 3.1518022572607 0.808329139714998 +220.55 13.7943227818466 3.15180330429966 0.825968943072552 +228.02 13.7952226084699 3.15180435055794 0.818568190765209 +236.45 13.7961224353932 3.15180539603555 0.823131251515797 +242.39 13.7970222626164 3.15180644073247 0.817069079299068 +248.8 13.7979220901392 3.15180748464871 0.802020933977456 +247.04 13.7988219179615 3.15180852778426 0.799465530752075 +242.31 13.7997217460829 3.15180957013913 0.815362113421493 +254.84 13.8006215745033 3.15181061171331 0.794524077109477 +238.67 13.7115411588254 3.15079923532473 0.818374769317107 +235.83 13.7124409561061 3.15080035307851 0.809884070916753 +239.54 13.7133407537075 3.15080147005195 0.802105554560407 +241.65 13.7142405516293 3.15080258624505 0.806632602704365 +238.72 13.7151403498714 3.15080370165782 0.826378786451629 +244.52 13.7160401484335 3.15080481629026 0.827085921307721 +244.06 13.7169399473154 3.15080593014235 0.811247185657492 +240.16 13.7178397465168 3.1508070432141 0.815135898443755 +243.54 13.7187395460376 3.15080815550551 0.808996514128903 +242.25 13.7196393458776 3.15080926701658 0.811356822270274 +246.09 13.7205391460364 3.1508103777473 0.809693957377443 +249.17 13.7214389465139 3.15081148769768 0.813205485246942 +250.82 13.7223387473099 3.15081259686771 0.820286307095802 +240.5 13.7232385484241 3.15081370525739 0.824582891142852 +250.28 13.7241383498562 3.15081481286672 0.826835806833163 +237.13 13.7250381516062 3.1508159196957 0.823538606382476 +239.34 13.7259379536737 3.15081702574433 0.823678193769649 +236.91 13.7268377560586 3.1508181310126 0.810640692839586 +242.12 13.7277375587606 3.15081923550052 0.8225889596907 +237.73 13.7286373617794 3.15082033920808 0.820919904779075 +231.42 13.7295371651149 3.15082144213528 0.824296243141828 +249 13.7304369687669 3.15082254428212 0.835204345982949 +244.15 13.731336772735 3.15082364564861 0.824689062922704 +237.13 13.7322365770192 3.15082474623473 0.817343702836956 +231.27 13.7331363816191 3.15082584604048 0.814082346588197 +237.05 13.7340361865345 3.15082694506587 0.810778061719861 +236.36 13.7349359917653 3.1508280433109 0.810634497498196 +240.3 13.7358357973111 3.15082914077556 0.812548288264287 +247.72 13.7367356031719 3.15083023745985 0.807298808530349 +228.22 13.7376354093472 3.15083133336376 0.831220635845863 +245.02 13.738535215837 3.15083242848731 0.83200469803641 +245.16 13.739435022641 3.15083352283048 0.823987061152784 +244.27 13.740334829759 3.15083461639328 0.821938813277921 +260.27 13.7412346371907 3.15083570917571 0.814755244755245 +247.49 13.7421344449359 3.15083680117775 0.825792173480417 +243.83 13.7430342529944 3.15083789239942 0.815471003263386 +255.01 13.743934061366 3.15083898284071 0.815702043368746 +248.95 13.7448338700505 3.15084007250162 0.823041060179671 +245.48 13.7457336790476 3.15084116138214 0.819954459446458 +249.08 13.746633488357 3.15084224948228 0.833701759085056 +250.63 13.7475332979787 3.15084333680204 0.814998695336356 +251.22 13.7484331079123 3.15084442334141 0.8183443688193 +255.73 13.7493329181577 3.15084550910039 0.825372578116344 +254.43 13.7502327287146 3.15084659407898 0.808040659412263 +248.05 13.7511325395827 3.15084767827718 0.808637664180954 +257.07 13.7520323507619 3.15084876169499 0.813849875437773 +231.98 13.752932162252 3.15084984433241 0.81382438776805 +244.16 13.7538319740526 3.15085092618943 0.812920895516687 +247.26 13.7547317861637 3.15085200726605 0.797418535103894 +244 13.7556315985849 3.15085308756228 0.811633172404116 +236.3 13.7565314113161 3.15085416707811 0.810242903131402 +237.21 13.7574312243569 3.15085524581354 0.813258857959365 +238.78 13.7583310377073 3.15085632376857 0.814008257912575 +241.53 13.7592308513669 3.1508574009432 0.808159669016243 +236.67 13.7601306653356 3.15085847733742 0.805212957742005 +234.07 13.7610304796131 3.15085955295124 0.812793429501446 +239.14 13.7619302941992 3.15086062778465 0.81830755502677 +242.65 13.7628301090937 3.15086170183765 0.812483750169774 +260.23 13.7637299242963 3.15086277511025 0.816930937769015 +294.59 13.7646297398068 3.15086384760243 0.795535226223163 +286.11 13.7655295556251 3.1508649193142 0.803175330273157 +257.89 13.7664293717508 3.15086599024556 0.778874991712395 +259.62 13.7673291881838 3.15086706039651 0.819252562757285 +264.51 13.7682290049238 3.15086812976704 0.824424390601541 +275.09 13.7691288219706 3.15086919835715 0.811182448287642 +287 13.7700286393239 3.15087026616684 0.807938579939496 +276.55 13.7709284569837 3.15087133319611 0.822684716025108 +281.92 13.7718282749496 3.15087239944497 0.813273488704013 +279.16 13.7727280932213 3.1508734649134 0.802986369475634 +275.22 13.7736279117988 3.1508745296014 0.805456200273381 +268.37 13.7745277306817 3.15087559350898 0.801009815350021 +265.1 13.7754275498699 3.15087665663614 0.812710203448264 +266.6 13.7763273693631 3.15087771898287 0.810334909247198 +283.96 13.7772271891611 3.15087878054917 0.78267983720051 +266.31 13.7781270092636 3.15087984133503 0.795839846098353 +268.67 13.7790268296705 3.15088090134047 0.812979066448168 +251.73 13.7799266503815 3.15088196056548 0.811350741063017 +243.45 13.7808264713964 3.15088301901005 0.816855695067913 +241.67 13.7817262927149 3.15088407667418 0.81163922278639 +242.42 13.7826261143369 3.15088513355788 0.79227452858947 +250.81 13.7835259362621 3.15088618966114 0.795156157127702 +257.44 13.7844257584903 3.15088724498396 0.809199690293517 +265.22 13.7853255810213 3.15088829952634 0.829834889973054 +265.89 13.7862254038549 3.15088935328828 0.808532346481747 +268.52 13.7871252269907 3.15089040626977 0.804884262371648 +255.64 13.7880250504287 3.15089145847082 0.803565041570253 +256.45 13.7889248741686 3.15089250989143 0.807901942313402 +246.83 13.78982469821 3.15089356053158 0.808221709006928 +244.29 13.790724522553 3.15089461039129 0.803254599740507 +239.63 13.7916243471971 3.15089565947055 0.805930299573047 +222.88 13.7925241721422 3.15089670776936 0.819216201957527 +234.24 13.7934239973881 3.15089775528771 0.814383163561837 +238.38 13.7943238229345 3.15089880202562 0.810093068343353 +241.93 13.7952236487812 3.15089984798306 0.807167327873543 +243.08 13.796123474928 3.15090089316005 0.813048310981027 +250.39 13.7970233013747 3.15090193755659 0.793874443895205 +251.15 13.7979231281209 3.15090298117266 0.789622495457397 +245.3 13.7988229551667 3.15090402400828 0.800211551002879 +248.36 13.7997227825115 3.15090506606343 0.81483176069966 +237.82 13.8006226101554 3.15090610733812 0.805106302798103 +240.56 13.7115422710276 3.14989476167176 0.816032139971907 +241.41 13.7124420675321 3.14989587910405 0.811794548511047 +263.65 13.7133418643573 3.14989699575623 0.813058520230287 +254.92 13.7142416615029 3.1498981116283 0.811196403076096 +245.67 13.7151414589688 3.14989922672026 0.821643266461267 +251.12 13.7160412567547 3.1499003410321 0.829597265039589 +244.57 13.7169410548604 3.14990145456383 0.812486988915469 +243.93 13.7178408532857 3.14990256731544 0.818526676891652 +239.01 13.7187406520303 3.14990367928694 0.816762122109821 +249.72 13.719640451094 3.14990479047831 0.805992830707259 +242.37 13.7205402504767 3.14990590088957 0.818002170847893 +241.48 13.721440050178 3.14990701052071 0.822521178689032 +245.47 13.7223398501977 3.14990811937172 0.818593866761647 +248.2 13.7232396505357 3.14990922744261 0.81068830804429 +249.17 13.7241394511917 3.14991033473337 0.819682176840772 +238.21 13.7250392521655 3.14991144124401 0.812932720755898 +235.98 13.7259390534568 3.14991254697451 0.827656757732579 +235.02 13.7268388550655 3.14991365192489 0.819127955866105 +236.76 13.7277386569912 3.14991475609514 0.819898207470884 +231.52 13.7286384592339 3.14991585948525 0.819072403999831 +236.4 13.7295382617931 3.14991696209524 0.820284530749189 +241.41 13.7304380646689 3.14991806392508 0.826892548776667 +250.18 13.7313378678608 3.14991916497479 0.832977273386372 +243.53 13.7322376713687 3.14992026524436 0.816391604726163 +234.73 13.7331374751924 3.1499213647338 0.817494795909132 +248.56 13.7340372793317 3.14992246344309 0.806846801798655 +235.07 13.7349370837862 3.14992356137224 0.815705697701966 +245.46 13.7358368885559 3.14992465852125 0.822983483352268 +237.31 13.7367366936404 3.14992575489011 0.807434798653422 +234.2 13.7376364990395 3.14992685047883 0.820596600402486 +243.92 13.7385363047531 3.14992794528739 0.809621643995409 +232.76 13.7394361107808 3.14992903931582 0.812708084678686 +249.51 13.7403359171225 3.14993013256409 0.822265825998065 +253.95 13.741235723778 3.14993122503221 0.807232599106116 +251.79 13.742135530747 3.14993231672017 0.801579233120898 +246.63 13.7430353380293 3.14993340762799 0.788794193327681 +251.74 13.7439351456247 3.14993449775565 0.795544346364018 +256.8 13.7448349535329 3.14993558710315 0.794335919639277 +262.91 13.7457347617538 3.14993667567049 0.779597489530551 +258.85 13.746634570287 3.14993776345767 0.794775526218768 +250.73 13.7475343791324 3.1499388504647 0.80815676862328 +254.34 13.7484341882898 3.14993993669156 0.812961698429449 +262.54 13.749333997759 3.14994102213825 0.822826705620314 +266.61 13.7502338075396 3.14994210680479 0.806330015700542 +254.23 13.7511336176315 3.14994319069115 0.819765866536978 +257.84 13.7520334280345 3.14994427379735 0.807567207319458 +250.51 13.7529332387483 3.14994535612338 0.806257399998452 +253.71 13.7538330497727 3.14994643766924 0.793230541427928 +235.94 13.7547328611075 3.14994751843493 0.814366479475107 +236.75 13.7556326727524 3.14994859842045 0.818847623641153 +238.02 13.7565324847073 3.14994967762579 0.805827006068646 +248.77 13.757432296972 3.14995075605096 0.80416658681028 +239.66 13.7583321095461 3.14995183369595 0.822461983963075 +234.25 13.7592319224294 3.14995291056076 0.817936803658348 +224.91 13.7601317356219 3.14995398664539 0.80368971141364 +234.01 13.7610315491231 3.14995506194985 0.816958163186686 +247.71 13.7619313629329 3.14995613647412 0.810893881773326 +253.41 13.7628311770511 3.1499572102182 0.816659819967857 +261.97 13.7637309914775 3.14995828318211 0.790702533298511 +293.67 13.7646308062118 3.14995935536582 0.785862482682734 +267.18 13.7655306212538 3.14996042676935 0.782195216121692 +253.53 13.7664304366032 3.14996149739269 0.799013816262714 +261.4 13.7673302522599 3.14996256723584 0.819142777714183 +266.86 13.7682300682236 3.1499636362988 0.812730523829318 +275.39 13.7691298844942 3.14996470458156 0.817075969703925 +289.33 13.7700297010713 3.14996577208414 0.80475025226265 +257.41 13.7709295179548 3.14996683880651 0.811708271399082 +268.69 13.7718293351444 3.14996790474869 0.81402183316713 +263.29 13.7727291526399 3.14996896991068 0.808513128364703 +262.31 13.7736289704411 3.14997003429246 0.800083266296908 +272.76 13.7745287885477 3.14997109789404 0.796820287967487 +300.05 13.7754286069596 3.14997216071542 0.779003805584549 +314.87 13.7763284256765 3.1499732227566 0.744803461407082 +311.62 13.7772282446982 3.14997428401757 0.684029738534792 +282.08 13.7781280640245 3.14997534449834 0.806613884048507 +269.08 13.779027883655 3.1499764041989 0.824432288022391 +260.23 13.7799277035898 3.14997746311925 0.817547381432743 +245.56 13.7808275238284 3.1499785212594 0.829142724729572 +232.42 13.7817273443706 3.14997957861933 0.826253841039372 +244.7 13.7826271652163 3.14998063519905 0.814638056571984 +247.87 13.7835269863653 3.14998169099855 0.81179046893322 +255.86 13.7844268078172 3.14998274601784 0.797418539442765 +262.17 13.7853266295719 3.14998380025692 0.811315253272426 +257.48 13.7862264516291 3.14998485371578 0.81582629606452 +266.61 13.7871262739887 3.14998590639441 0.805303310604859 +244.56 13.7880260966504 3.14998695829283 0.823672033128545 +242.31 13.7889259196139 3.14998800941103 0.808472166414243 +244.62 13.7898257428791 3.149989059749 0.816531756262282 +242.6 13.7907255664457 3.14999010930675 0.806105176695467 +243.31 13.7916253903136 3.14999115808428 0.811456751232866 +228.43 13.7925252144824 3.14999220608158 0.823669244425721 +230.47 13.7934250389519 3.14999325329865 0.822452558920278 +237.03 13.794324863722 3.14999429973549 0.813870593986612 +252.33 13.7952246887924 3.1499953453921 0.813514810142327 +248.2 13.7961245141629 3.14999639026848 0.811534060569075 +247.26 13.7970243398333 3.14999743436463 0.808828944945682 +237.86 13.7979241658033 3.14999847768054 0.809759793423891 +242.67 13.7988239920727 3.14999952021622 0.813045165617311 +248.55 13.7997238186412 3.15000056197165 0.808786690524232 +237.42 13.8006236455088 3.15000160294686 0.811541321929906 +232.6 13.7115433829089 3.14899028800267 0.810845459888682 +240.91 13.7124431786374 3.14899140511347 0.811048718132692 +252.39 13.7133429746866 3.14899252144439 0.811098407625765 +248.5 13.7142427710563 3.14899363699542 0.821738398896255 +257.1 13.7151425677462 3.14899475176657 0.813491969868046 +248.28 13.7160423647562 3.14899586575782 0.804174924712363 +241.51 13.7169421620859 3.14899697896919 0.816890736290619 +240.68 13.7178419597352 3.14899809140066 0.823276473760395 +241.02 13.7187417577039 3.14899920305224 0.808743461086794 +239.85 13.7196415559916 3.14900031392393 0.815701903031048 +239.36 13.7205413545983 3.14900142401572 0.822320856278387 +241.29 13.7214411535236 3.14900253332762 0.828889987554768 +244.43 13.7223409527674 3.14900364185961 0.815415835893652 +245.89 13.7232407523294 3.14900474961171 0.806675693618745 +239.18 13.7241405522094 3.1490058565839 0.812753795330537 +241.76 13.7250403524072 3.1490069627762 0.816809659993645 +233.86 13.7259401529225 3.14900806818859 0.819274799679203 +237.39 13.7268399537552 3.14900917282107 0.819226742557176 +234.66 13.727739754905 3.14901027667365 0.807585817373204 +231.95 13.7286395563716 3.14901137974632 0.816312585174518 +235.64 13.7295393581549 3.14901248203908 0.816572398843374 +239.86 13.7304391602547 3.14901358355193 0.806261763796659 +245.62 13.7313389626706 3.14901468428486 0.817241528541135 +245.66 13.7322387654026 3.14901578423789 0.839565602495475 +247.11 13.7331385684503 3.149016883411 0.817988507382016 +242.29 13.7340383718135 3.14901798180419 0.819560337763209 +232.65 13.7349381754921 3.14901907941747 0.810307548572845 +239.73 13.7358379794857 3.14902017625083 0.811978640929712 +230.32 13.7367377837942 3.14902127230426 0.798822325906335 +230.4 13.7376375884173 3.14902236757778 0.805900413829929 +236.49 13.7385373933549 3.14902346207137 0.806746478928542 +240.99 13.7394371986067 3.14902455578504 0.814627144500665 +244.61 13.7403370041724 3.14902564871878 0.821440214910736 +257.97 13.7412368100519 3.1490267408726 0.75972806023612 +242.95 13.7421366162449 3.14902783224649 0.768838631228879 +243.63 13.7430364227511 3.14902892284045 0.805808936379695 +239.94 13.7439362295705 3.14903001265448 0.817495692089633 +249.74 13.7448360367027 3.14903110168857 0.808167276341503 +251.35 13.7457358441476 3.14903218994273 0.797884991720608 +247.51 13.7466356519048 3.14903327741696 0.772972929403657 +264.47 13.7475354599742 3.14903436411125 0.751526492379301 +285.36 13.7484352683556 3.1490354500256 0.703267445426413 +263.54 13.7493350770487 3.14903653516002 0.797873272866874 +258.47 13.7502348860533 3.14903761951449 0.805502832657522 +251.15 13.7511346953692 3.14903870308903 0.810813288690531 +245.8 13.7520345049961 3.14903978588362 0.805853787197071 +255.5 13.7529343149339 3.14904086789826 0.803561124392053 +256.06 13.7538341251823 3.14904194913296 0.804395043273304 +240.71 13.7547339357411 3.14904302958771 0.818542666862338 +235.67 13.75563374661 3.14904410926252 0.821152751808796 +243.78 13.7565335577889 3.14904518815737 0.805894211385236 +243.49 13.7574333692775 3.14904626627228 0.816834311564952 +248.06 13.7583331810756 3.14904734360723 0.812220211979478 +254.89 13.7592329931829 3.14904842016223 0.805259869270286 +242.53 13.7601328055993 3.14904949593727 0.812858311285869 +243.24 13.7610326183245 3.14905057093236 0.806336467349462 +246.22 13.7619324313583 3.14905164514749 0.804327411706967 +250.78 13.7628322447005 3.14905271858266 0.815832915184967 +253.72 13.7637320583508 3.14905379123787 0.809199758172729 +263.1 13.764631872309 3.14905486311311 0.793234617944219 +260.94 13.765531686575 3.1490559342084 0.81343755274122 +266.28 13.7664315011484 3.14905700452372 0.825201405056826 +263.96 13.7673313160291 3.14905807405908 0.82307616287781 +267.37 13.7682311312167 3.14905914281447 0.817574184623639 +278.07 13.7691309467112 3.14906021078989 0.801833955812132 +276.69 13.7700307625123 3.14906127798534 0.805170736227587 +266.93 13.7709305786197 3.14906234440082 0.795370390577828 +263.31 13.7718303950333 3.14906341003633 0.806730587161964 +262.63 13.7727302117527 3.14906447489186 0.806219938292339 +270.38 13.7736300287779 3.14906553896742 0.784129571010193 +283.62 13.7745298461085 3.14906660226301 0.772468276404806 +328.38 13.7754296637443 3.14906766477862 0.71751039255372 +358.36 13.7763294816851 3.14906872651424 0.607105288462939 +288.63 13.7772292999308 3.14906978746989 0.749750322022833 +290.91 13.778129118481 3.14907084764556 0.793821172225345 +292.47 13.7790289373355 3.14907190704125 0.800897641719208 +259.44 13.7799287564941 3.14907296565695 0.819309354834382 +251.71 13.7808285759567 3.14907402349266 0.8138988898353 +241.36 13.7817283957229 3.14907508054839 0.799652459932043 +242.13 13.7826282157925 3.14907613682413 0.81496029531858 +246.35 13.7835280361654 3.14907719231988 0.814940577249576 +254.51 13.7844278568413 3.14907824703565 0.812042328661005 +257.94 13.7853276778199 3.14907930097142 0.810603947592432 +260.85 13.7862274991011 3.14908035412719 0.807252075780611 +262.22 13.7871273206846 3.14908140650297 0.798070963157815 +254.5 13.7880271425702 3.14908245809876 0.810420148139365 +252.67 13.7889269647576 3.14908350891455 0.812891265806955 +246.09 13.7898267872467 3.14908455895034 0.802604226156482 +238.99 13.7907266100373 3.14908560820614 0.820636652380651 +238.06 13.791626433129 3.14908665668193 0.815125102465951 +234.43 13.7925262565218 3.14908770437772 0.813746069151717 +231.33 13.7934260802153 3.1490887512935 0.805236401631603 +236.63 13.7943259042093 3.14908979742929 0.799037076663512 +246.35 13.7952257285036 3.14909084278506 0.803301696044149 +246.9 13.796125553098 3.14909188736083 0.804268540838368 +243.57 13.7970253779923 3.14909293115659 0.813918749499853 +245.97 13.7979252031862 3.14909397417234 0.810743080468686 +246.17 13.7988250286795 3.14909501640808 0.810794241692334 +238.92 13.799724854472 3.1490960578638 0.80740507885075 +229.22 13.8006246805634 3.14909709853952 0.805587633801279 +231.25 13.7115444944693 3.14808581431745 0.817128881577015 +241.94 13.712444289422 3.14808693110677 0.82159050599346 +258.06 13.7133440846955 3.14808804711643 0.809854258635201 +258 13.7142438802895 3.14808916234642 0.813197914842603 +266.25 13.7151436762036 3.14809027679676 0.809263175622063 +253.58 13.7160434724378 3.14809139046743 0.809973833119597 +247.85 13.7169432689918 3.14809250335843 0.810188490646866 +241.84 13.7178430658654 3.14809361546976 0.81584137634035 +235.94 13.7187428630583 3.14809472680143 0.815129203911768 +234.11 13.7196426605703 3.14809583735343 0.831697180570513 +237.8 13.7205424584012 3.14809694712576 0.833355340450096 +238.4 13.7214422565508 3.14809805611841 0.820101281335039 +236.69 13.7223420550188 3.14809916433139 0.819759874819029 +243.41 13.7232418538051 3.1481002717647 0.813881902199345 +236.33 13.7241416529093 3.14810137841832 0.814452554190436 +236.94 13.7250414523314 3.14810248429227 0.819886963542637 +234.29 13.7259412520709 3.14810358938654 0.819515196976262 +241.45 13.7268410521279 3.14810469370114 0.816289083887006 +234.67 13.7277408525019 3.14810579723604 0.821107649155275 +238.7 13.7286406531928 3.14810689999127 0.807202510938393 +244.3 13.7295404542003 3.14810800196681 0.814958760401219 +244.06 13.7304402555243 3.14810910316266 0.818834251936491 +248.57 13.7313400571645 3.14811020357883 0.81497887684938 +252.2 13.7322398591206 3.1481113032153 0.822256909686286 +255.63 13.7331396613926 3.14811240207209 0.798548840761712 +243.79 13.73403946398 3.14811350014919 0.807789249366205 +257.91 13.7349392668828 3.14811459744659 0.787605140685709 +254.54 13.7358390701007 3.1481156939643 0.792228015601534 +266.37 13.7367388736334 3.14811678970231 0.813320695102686 +248.04 13.7376386774808 3.14811788466063 0.82042214392637 +246.79 13.7385384816426 3.14811897883924 0.820274847480346 +244.85 13.7394382861185 3.14812007223816 0.799587114708528 +239.82 13.7403380909085 3.14812116485738 0.84514879951772 +238.05 13.7412378960122 3.14812225669689 0.860607005277339 +225.58 13.7421377014294 3.1481233477567 0.815175709761232 +234.9 13.7430375071599 3.14812443803681 0.813958148561844 +234.21 13.7439373132035 3.1481255275372 0.811097356675089 +238.87 13.7448371195599 3.1481266162579 0.80851121328994 +239.03 13.745736926229 3.14812770419888 0.817302006259645 +241.69 13.7466367332104 3.14812879136015 0.812609053497942 +243.08 13.747536540504 3.14812987774171 0.814784745143781 +252.59 13.7484363481096 3.14813096334355 0.793630628892586 +268.72 13.7493361560269 3.14813204816569 0.745151517385247 +261.43 13.7502359642557 3.1481331322081 0.757519996438482 +251.88 13.7511357727958 3.1481342154708 0.783495557814624 +255.56 13.752035581647 3.14813529795378 0.79137338574703 +250.5 13.752935390809 3.14813637965704 0.795554739864723 +244.9 13.7538352002816 3.14813746058058 0.810798661405524 +238.23 13.7547350100645 3.1481385407244 0.819050043199409 +239.37 13.7556348201577 3.14813962008849 0.818274219318419 +242.99 13.7565346305608 3.14814069867286 0.8105841638341 +244.15 13.7574344412735 3.1481417764775 0.816121391078496 +242.27 13.7583342522958 3.14814285350241 0.80182278360683 +245.14 13.7592340636274 3.1481439297476 0.808056517586957 +249.12 13.7601338752679 3.14814500521305 0.805136088938703 +239.27 13.7610336872173 3.14814607989877 0.817382134314154 +239.57 13.7619334994753 3.14814715380476 0.80778267827173 +243.75 13.7628333120417 3.14814822693102 0.808462511068234 +242.22 13.7637331249162 3.14814929927754 0.804860741529182 +253.71 13.7646329380986 3.14815037084432 0.810080161211457 +255.47 13.7655327515887 3.14815144163136 0.818168761220826 +271.04 13.7664325653863 3.14815251163867 0.831659926898303 +254.26 13.7673323794912 3.14815358086623 0.825425201155112 +266.43 13.768232193903 3.14815464931405 0.814647666151053 +268.4 13.7691320086217 3.14815571698213 0.802915365664293 +286.51 13.7700318236469 3.14815678387046 0.755279460114207 +296.75 13.7709316389785 3.14815784997904 0.731597802189626 +299.79 13.7718314546163 3.14815891530788 0.7524234481242 +297.32 13.7727312705599 3.14815997985697 0.760380260951772 +351.8 13.7736310868092 3.14816104362631 0.665173040698074 +455.3 13.774530903364 3.14816210661589 0.468373912367067 +336.3 13.775430720224 3.14816316882573 0.673544544073476 +342.87 13.776330537389 3.14816423025581 0.632147106106616 +279.73 13.7772303548588 3.14816529090613 0.79304786365947 +283.53 13.7781301726331 3.1481663507767 0.795510014460606 +290.76 13.7790299907118 3.14816740986751 0.795165848530794 +284.69 13.7799298090947 3.14816846817856 0.805305319528514 +250.61 13.7808296277814 3.14816952570985 0.821837669775814 +247.14 13.7817294467717 3.14817058246137 0.80320602110156 +252.41 13.7826292660655 3.14817163843314 0.81478229694828 +264.44 13.7835290856625 3.14817269362513 0.80861992448108 +255.56 13.7844289055626 3.14817374803737 0.80684811237928 +259.71 13.7853287257653 3.14817480166983 0.79082682103232 +253.55 13.7862285462707 3.14817585452253 0.789296987317982 +254.42 13.7871283670783 3.14817690659546 0.823496821010385 +266.19 13.7880281881881 3.14817795788861 0.81964404807051 +260.81 13.7889280095997 3.148179008402 0.806206737757055 +246.61 13.789827831313 3.14818005813561 0.81045218873641 +241.15 13.7907276533276 3.14818110708944 0.805723067419497 +237.21 13.7916274756435 3.1481821552635 0.821872353725772 +228.87 13.7925272982604 3.14818320265778 0.804506516449452 +227.22 13.793427121178 3.14818424927229 0.807987532949817 +248.7 13.7943269443962 3.14818529510701 0.806815180065158 +244.8 13.7952267679147 3.14818634016195 0.806593560103374 +250.33 13.7961265917332 3.14818738443711 0.804583864052937 +250.46 13.7970264158516 3.14818842793248 0.80862432269717 +253.37 13.7979262402696 3.14818947064807 0.810326309051523 +235.43 13.7988260649871 3.14819051258387 0.799680073515022 +229.94 13.7997258900037 3.14819155373988 0.801200800533689 +230.36 13.8006257153193 3.14819259411611 0.811604192911982 +239.8 13.7115456057087 3.14718134061612 0.805416844567376 +250.38 13.712445399886 3.14718245708395 0.804023978552436 +258.28 13.713345194384 3.14718357277235 0.815924008369753 +271.71 13.7142449892024 3.14718468768131 0.80220229310932 +269.16 13.715144784341 3.14718580181083 0.806952441336161 +255.42 13.7160445797997 3.14718691516092 0.807454316929324 +247.3 13.7169443755782 3.14718802773156 0.814751574715812 +245.3 13.7178441716762 3.14718913952276 0.817757350766651 +238.33 13.7187439680936 3.14719025053451 0.822781122893021 +231.53 13.7196437648301 3.14719136076682 0.809079489013007 +230.94 13.7205435618855 3.14719247021968 0.8065053219956 +236.9 13.7214433592595 3.1471935788931 0.816603828306265 +239.23 13.722343156952 3.14719468678706 0.82030537623471 +242.88 13.7232429549628 3.14719579390157 0.810078870778909 +247.23 13.7241427532915 3.14719690023664 0.809517557296454 +236.81 13.725042551938 3.14719800579224 0.813140822109082 +238.83 13.725942350902 3.1471991105684 0.816701247451862 +239.54 13.7268421501834 3.14720021456509 0.809484814905246 +240.33 13.7277419497819 3.14720131778233 0.816399853005712 +250.31 13.7286417496972 3.14720242022011 0.802082638502872 +252.78 13.7295415499292 3.14720352187843 0.802152558680719 +254.58 13.7304413504777 3.14720462275729 0.790113828941646 +267.07 13.7313411513423 3.14720572285669 0.778795373536044 +276.49 13.7322409525229 3.14720682217662 0.753112934119239 +285.34 13.7331407540193 3.14720792071708 0.727825886720304 +258.3 13.7340405558313 3.14720901847808 0.747533539426391 +260.44 13.7349403579585 3.14721011545961 0.766401315597986 +257.16 13.7358401604008 3.14721121166167 0.77229001226677 +274.63 13.736739963158 3.14721230708426 0.749960680265596 +247.46 13.7376397662298 3.14721340172737 0.769910857009083 +234.64 13.738539569616 3.14721449559101 0.821656050955414 +230.48 13.7394393733165 3.14721558867518 0.859108315019059 +237.07 13.7403391773309 3.14721668097987 0.865662353616254 +233.21 13.741238981659 3.14721777250508 0.859512438851512 +227.54 13.7421387863006 3.14721886325081 0.831275720164609 +231.09 13.7430385912556 3.14721995321707 0.820747543945496 +243.2 13.7439383965236 3.14722104240384 0.817498483346404 +240.34 13.7448382021045 3.14722213081112 0.812873367277512 +236.13 13.745738007998 3.14722321843892 0.821998864612294 +231.83 13.7466378142038 3.14722430528724 0.817150271113478 +236.04 13.7475376207219 3.14722539135607 0.816482041205103 +234.23 13.7484374275519 3.14722647664541 0.820386852308777 +242.12 13.7493372346937 3.14722756115526 0.818686348756274 +248.77 13.7502370421469 3.14722864488562 0.804701214025461 +257.17 13.7511368499114 3.14722972783648 0.773807420016806 +261.43 13.752036657987 3.14723081000785 0.752302919417708 +258.39 13.7529364663734 3.14723189139973 0.77493313374352 +245.26 13.7538362750704 3.14723297201211 0.791656452333915 +250.83 13.7547360840778 3.14723405184499 0.782993854738416 +256.31 13.7556358933954 3.14723513089837 0.767100440781774 +259.14 13.7565357030229 3.14723620917226 0.775749994577046 +254.19 13.7574355129601 3.14723728666664 0.77717732276279 +248.45 13.7583353232068 3.14723836338151 0.79397177744706 +247.19 13.7592351337627 3.14723943931688 0.808474651382652 +242.92 13.7601349446277 3.14724051447275 0.809851274944978 +240.92 13.7610347558015 3.14724158884911 0.810889107905504 +242.66 13.7619345672839 3.14724266244596 0.801851128641725 +249.45 13.7628343790747 3.1472437352633 0.799455330040343 +240.41 13.7637341911736 3.14724480730112 0.799963989196759 +246.24 13.7646340035805 3.14724587855944 0.811470625180106 +251.93 13.765533816295 3.14724694903824 0.802550455814934 +268.55 13.766433629317 3.14724801873753 0.814803130780138 +277.38 13.7673334426462 3.1472490876573 0.820690555933911 +282.36 13.7682332562825 3.14725015579755 0.799313433725168 +335.38 13.7691330702256 3.14725122315828 0.661258701520102 +343.35 13.7700328844752 3.14725228973949 0.55108428347865 +305.7 13.7709326990312 3.14725335554118 0.686378653292101 +323.65 13.7718325138934 3.14725442056335 0.65108143030164 +365.11 13.7727323290614 3.14725548480599 0.554456773797888 +435.16 13.7736321445351 3.14725654826911 0.426184502696312 +360.72 13.7745319603143 3.1472576109527 0.637867791506495 +294.42 13.7754317763987 3.14725867285676 0.76628408327498 +285.75 13.7763315927881 3.14725973398129 0.790802952898066 +278.55 13.7772314094822 3.14726079432629 0.797993908898305 +292.38 13.778131226481 3.14726185389176 0.793464942137509 +274.27 13.7790310437841 3.14726291267769 0.806539528195296 +284.01 13.7799308613913 3.14726397068409 0.79412117896647 +279.24 13.7808306793024 3.14726502791095 0.804742319476516 +272.11 13.7817304975171 3.14726608435828 0.801957350365716 +270.07 13.7826303160353 3.14726714002607 0.799498159306947 +266.16 13.7835301348567 3.14726819491431 0.812840661181893 +264.13 13.7844299539811 3.14726924902302 0.807673165251767 +264.54 13.7853297734082 3.14727030235218 0.802218517156556 +259.85 13.7862295931379 3.1472713549018 0.808407335840001 +280.73 13.78712941317 3.14727240667187 0.823710794646579 +273.68 13.7880292335041 3.1472734576624 0.812869948936967 +263.81 13.7889290541401 3.14727450787337 0.815422342408922 +257.72 13.7898288750777 3.1472755573048 0.809043845441925 +244.14 13.7907286963168 3.14727660595668 0.821244558779713 +235.99 13.7916285178571 3.14727765382901 0.812854251012146 +227.59 13.7925283396983 3.14727870092178 0.818173739886985 +238.63 13.7934281618403 3.147279747235 0.817121377562861 +242.25 13.7943279842828 3.14728079276866 0.810199775703777 +253.88 13.7952278070257 3.14728183752277 0.799629981735772 +256.8 13.7961276300686 3.14728288149732 0.805792304509723 +251.29 13.7970274534113 3.1472839246923 0.814322387262394 +238.97 13.7979272770537 3.14728496710773 0.795915847696182 +237.43 13.7988271009955 3.1472860087436 0.79852612624629 +243.59 13.7997269252365 3.1472870495999 0.796905168312953 +253.2 13.8006267497765 3.14728808967664 0.79611382335207 +253.72 13.7115467166273 3.14627686689868 0.790317027686128 +256.61 13.7124465100292 3.14627798304503 0.809247954888678 +270.86 13.7133463037519 3.14627909841216 0.806108872560638 +282.54 13.714246097795 3.14628021300009 0.785281240017939 +279.52 13.7151458921584 3.1462813268088 0.793704555629313 +285.69 13.7160456868418 3.1462824398383 0.801027335197074 +253.49 13.716945481845 3.14628355208858 0.799852853394783 +239.75 13.7178452771677 3.14628466355964 0.811262923870578 +244.09 13.7187450728098 3.14628577425148 0.815841563564889 +244.88 13.719644868771 3.1462868841641 0.799477371927406 +254.44 13.7205446650511 3.1462879932975 0.771418203975723 +278.84 13.7214444616498 3.14628910165167 0.756294381402629 +264.06 13.722344258567 3.14629020922662 0.790781464341656 +249.48 13.7232440558024 3.14629131602235 0.829496136915062 +248.76 13.7241438533559 3.14629242203884 0.822192633523626 +247.78 13.725043651227 3.14629352727611 0.807502201516916 +255.46 13.7259434494158 3.14629463173415 0.8004887560686 +251.66 13.7268432479218 3.14629573541295 0.802919599631709 +256.88 13.727743046745 3.14629683831252 0.807926562012392 +256.42 13.728642845885 3.14629794043286 0.79950567965455 +259.92 13.7295426453417 3.14629904177396 0.766091598187234 +282.85 13.7304424451149 3.14630014233582 0.678627682614688 +273.71 13.7313422452042 3.14630124211845 0.754039402073012 +272.39 13.7322420456095 3.14630234112183 0.781843152445681 +269.13 13.7331418463306 3.14630343934597 0.798496906310849 +259.89 13.7340416473672 3.14630453679087 0.798278378917668 +250.99 13.7349414487191 3.14630563345653 0.81270636854193 +251.31 13.7358412503861 3.14630672934294 0.806444950861701 +244.14 13.7367410523679 3.14630782445011 0.815115619616278 +238.52 13.7376408546644 3.14630891877802 0.819200387200705 +225.29 13.7385406572753 3.14631001232669 0.847405134736172 +222.77 13.7394404602004 3.14631110509611 0.851823890518584 +221.74 13.7403402634395 3.14631219708627 0.827896545698142 +229.07 13.7412400669923 3.14631328829718 0.811456312192689 +229.15 13.7421398708586 3.14631437872883 0.816349879488666 +236.5 13.7430396750382 3.14631546838123 0.822703463083273 +246.41 13.7439394795309 3.14631655725438 0.823629935587427 +247.18 13.7448392843364 3.14631764534826 0.818414623272403 +240.31 13.7457390894546 3.14631873266288 0.813172094155968 +230.59 13.7466388948851 3.14631981919824 0.815394868377208 +229.75 13.7475387006278 3.14632090495434 0.80801010984738 +233.72 13.7484385066825 3.14632198993117 0.821359675131171 +237.24 13.7493383130489 3.14632307412874 0.818385223802119 +247.13 13.7502381197268 3.14632415754704 0.818065109710826 +253.32 13.751137926716 3.14632524018608 0.791566399464533 +266.11 13.7520377340162 3.14632632204584 0.76961052770438 +254.6 13.7529375416273 3.14632740312633 0.801257567680073 +247.49 13.7538373495489 3.14632848342755 0.800825712279033 +240.53 13.754737157781 3.1463295629495 0.805398173505856 +245.91 13.7556369663232 3.14633064169217 0.805928451269503 +254.17 13.7565367751753 3.14633171965557 0.803387929826075 +251.93 13.7574365843372 3.14633279683969 0.784876594585597 +275.09 13.7583363938085 3.14633387324452 0.709937389174592 +279.1 13.7592362035891 3.14633494887008 0.746854942233633 +276.94 13.7601360136787 3.14633602371636 0.728113155549511 +275.72 13.7610358240772 3.14633709778335 0.737206759092673 +282.11 13.7619356347842 3.14633817107106 0.680356416102113 +276.07 13.7628354457996 3.14633924357949 0.692705969242132 +272.11 13.7637352571232 3.14634031530863 0.717244155534351 +253.44 13.7646350687546 3.14634138625848 0.80998775268684 +260.84 13.7655348806938 3.14634245642904 0.789539831984654 +274.77 13.7664346929404 3.14634352582031 0.765496629137161 +323.42 13.7673345054943 3.14634459443228 0.711465809196611 +300.03 13.7682343183552 3.14634566226497 0.732800609075617 +278.5 13.7691341315229 3.14634672931836 0.767113339030742 +277.61 13.7700339449972 3.14634779559245 0.764102669912929 +276.01 13.7709337587778 3.14634886108724 0.780650499742326 +288.41 13.7718335728645 3.14634992580274 0.770640036581948 +287.89 13.7727333872572 3.14635098973894 0.787381198210362 +289.9 13.7736332019555 3.14635205289583 0.731073632722148 +318.25 13.7745330169593 3.14635311527343 0.671654088368873 +289.23 13.7754328322683 3.14635417687171 0.774502437635305 +289.68 13.7763326478823 3.1463552376907 0.780026856828502 +278.33 13.7772324638011 3.14635629773037 0.805444526368893 +287 13.7781322800245 3.14635735699074 0.815809242109464 +281.58 13.7790320965522 3.1463584154718 0.808806824509433 +283.26 13.779931913384 3.14635947317355 0.798876655748918 +294.6 13.7808317305197 3.14636053009599 0.795482691887406 +293.04 13.781731547959 3.14636158623911 0.801677321127685 +298.36 13.7826313657018 3.14636264160293 0.802602723293789 +285.53 13.7835311837478 3.14636369618742 0.798739784141244 +290.66 13.7844310020968 3.1463647499926 0.794902462424048 +295.01 13.7853308207486 3.14636580301846 0.79531460161157 +295.54 13.7862306397029 3.14636685526499 0.811970672819003 +295.62 13.7871304589595 3.14636790673221 0.806649062063668 +269 13.7880302785183 3.14636895742011 0.817241222632593 +254.16 13.7889300983789 3.14637000732868 0.807729545967431 +258.34 13.7898299185411 3.14637105645793 0.814043862079608 +250.79 13.7907297390048 3.14637210480785 0.801333975963557 +260.5 13.7916295597696 3.14637315237845 0.808635481337699 +265.83 13.7925293808355 3.14637419916971 0.803970251076441 +261.16 13.793429202202 3.14637524518165 0.804125147286355 +257.44 13.7943290238691 3.14637629041425 0.810925860234125 +256.35 13.7952288458366 3.14637733486752 0.804560687184623 +262.89 13.7961286681041 3.14637837854146 0.798795604828179 +255.75 13.7970284906714 3.14637942143607 0.800874210781933 +241.01 13.7979283135384 3.14638046355133 0.804337891233221 +237 13.7988281367048 3.14638150488726 0.812712477117849 +238.84 13.7997279601703 3.14638254544385 0.800401195720579 +246.68 13.8006277839349 3.1463835852211 0.797840353698384 +290.63 13.7115478272249 3.14537239316513 0.688966415929509 +268.84 13.7124476198518 3.14537350898999 0.734330378863199 +289.52 13.7133474127994 3.14537462403587 0.730492851768247 +300.21 13.7142472060675 3.14537573830276 0.695741848566984 +279.33 13.7151469996558 3.14537685179067 0.74079355363785 +271.2 13.7160467935641 3.14537796449958 0.770181984896145 +269.56 13.7169465877922 3.14537907642949 0.762544068701278 +263.52 13.7178463823399 3.14538018758042 0.754521090289371 +248.32 13.7187461772069 3.14538129795235 0.758145609907705 +248.64 13.719645972393 3.14538240754528 0.776765528569141 +268.27 13.720545767898 3.14538351635922 0.753726715522528 +266.23 13.7214455637217 3.14538462439415 0.738429233233753 +254.99 13.7223453598638 3.14538573165009 0.791446171586869 +284.36 13.7232451563241 3.14538683812702 0.732590822620247 +285.71 13.7241449531024 3.14538794382495 0.731821165244567 +295.52 13.7250447501986 3.14538904874388 0.690868999229563 +279.71 13.7259445476122 3.1453901528838 0.731677269373721 +278.6 13.7268443453432 3.14539125624471 0.763543346169193 +298.19 13.7277441433913 3.14539235882661 0.717702709842643 +273.27 13.7286439417562 3.14539346062951 0.74658707649169 +265.32 13.7295437404378 3.14539456165339 0.767884623840303 +256.08 13.7304435394358 3.14539566189826 0.796904633012229 +269.66 13.7313433387501 3.14539676136411 0.805992320598436 +274.74 13.7322431383803 3.14539786005095 0.777388975736682 +247.78 13.7331429383263 3.14539895795877 0.809461197656138 +241.71 13.7340427385878 3.14540005508758 0.814455766656989 +246.34 13.7349425391646 3.14540115143736 0.823607093019298 +243.04 13.7358423400565 3.14540224700812 0.815378875124223 +244.29 13.7367421412632 3.14540334179986 0.822922466712036 +238.73 13.7376419427846 3.14540443581258 0.825216801735124 +227.23 13.7385417446204 3.14540552904627 0.823682406248137 +228.27 13.7394415467704 3.14540662150094 0.82112357180259 +228.57 13.7403413492343 3.14540771317658 0.82369420685088 +234.87 13.741241152012 3.14540880407319 0.819714785904369 +235.44 13.7421409551032 3.14540989419077 0.815946452870435 +245.12 13.7430407585077 3.14541098352931 0.815164438019516 +240.49 13.7439405622253 3.14541207208883 0.821607025783678 +239.72 13.7448403662557 3.14541315986931 0.812596596659423 +229.57 13.7457401705988 3.14541424687075 0.818466341309202 +229.38 13.7466399752542 3.14541533309316 0.825773829499222 +232.57 13.7475397802218 3.14541641853653 0.809342102664376 +226.72 13.7484395855013 3.14541750320085 0.823133849477717 +242.41 13.7493393910926 3.14541858708614 0.814677566665169 +251.73 13.7502391969954 3.14541967019239 0.802643850014063 +257.59 13.7511390032095 3.14542075251959 0.801539594053216 +264.96 13.7520388097346 3.14542183406774 0.792601030405908 +258.17 13.7529386165705 3.14542291483685 0.787532021291283 +261 13.753838423717 3.14542399482691 0.80165306793706 +254.26 13.7547382311739 3.14542507403793 0.795695077189811 +253.03 13.755638038941 3.14542615246989 0.794105722054628 +253.04 13.756537847018 3.1454272301228 0.804633817638045 +267.87 13.7574376554047 3.14542830699666 0.799584115230512 +284.19 13.7583374641009 3.14542938309146 0.796665853031013 +295.32 13.7592372731064 3.1454304584072 0.783549255637674 +281.8 13.7601370824209 3.14543153294389 0.774322160714099 +257.1 13.7610368920442 3.14543260670153 0.799524252917043 +245.88 13.7619367019761 3.1454336796801 0.788722144340006 +253.34 13.7628365122164 3.14543475187961 0.752059993707511 +257.14 13.7637363227648 3.14543582330005 0.743057095397591 +260.32 13.7646361336211 3.14543689394144 0.766184969033724 +268.81 13.7655359447851 3.14543796380376 0.73288277117932 +265.44 13.7664357562566 3.14543903288701 0.75651012514572 +265.68 13.7673355680353 3.1454401011912 0.799992291223558 +280.54 13.7682353801211 3.14544116871631 0.781535000432638 +255.82 13.7691351925136 3.14544223546236 0.792428183604621 +265.49 13.7700350052128 3.14544330142933 0.773183582316082 +274.51 13.7709348182182 3.14544436661723 0.793191974548063 +272.98 13.7718346315298 3.14544543102606 0.796557869436181 +276.18 13.7727344451473 3.14544649465581 0.784670503375742 +278.71 13.7736342590705 3.14544755750649 0.793037383335188 +286.54 13.7745340732991 3.14544861957808 0.764370729823037 +293.7 13.775433887833 3.1454496808706 0.715590551181102 +277.43 13.7763337026718 3.14545074138404 0.786098758043824 +265.17 13.7772335178155 3.14545180111839 0.795641037548807 +269.31 13.7781333332637 3.14545286007366 0.810958840946293 +274.15 13.7790331490162 3.14545391824985 0.788568065488399 +289.22 13.7799329650728 3.14545497564695 0.7616782884855 +303.69 13.7808327814334 3.14545603226496 0.73902987513054 +312.16 13.7817325980976 3.14545708810388 0.7535554195957 +310.91 13.7826324150652 3.14545814316372 0.736205387162668 +286.2 13.783532232336 3.14545919744446 0.782172865700183 +303.25 13.7844320499098 3.14546025094611 0.781039335233938 +302.26 13.7853318677864 3.14546130366867 0.736735106803226 +315.61 13.7862316859656 3.14546235561213 0.750022695924398 +290.11 13.787131504447 3.14546340677649 0.767679372775571 +260.88 13.7880313232306 3.14546445716176 0.819127790648694 +250.13 13.788931142316 3.14546550676793 0.808898114818659 +250.83 13.789830961703 3.145466555595 0.809905201972973 +258.03 13.7907307813915 3.14546760364296 0.798971115006478 +266.8 13.7916306013812 3.14546865091182 0.811763296344717 +271.27 13.7925304216718 3.14546969740158 0.798500544453927 +264.77 13.7934302422632 3.14547074311224 0.800166672980037 +269.18 13.7943300631552 3.14547178804378 0.803561752959456 +262.05 13.7952298843474 3.14547283219622 0.803557588845665 +256.51 13.7961297058397 3.14547387556955 0.802294473772336 +253.5 13.7970295276319 3.14547491816377 0.802526443954037 +247.9 13.7979293497236 3.14547595997888 0.809842210760014 +236.41 13.7988291721148 3.14547700101487 0.81467969665686 +241.98 13.7997289948052 3.14547804127175 0.80147218268628 +248.99 13.8006288177945 3.14547908074951 0.798735144902356 +249.71 13.7115489375016 3.14446791941547 0.798796254525049 +244.37 13.7124487293537 3.14446903491886 0.813234620130442 +252.05 13.7133485215265 3.14447014964348 0.79730828031407 +252.52 13.7142483140197 3.14447126358934 0.801578614218719 +254.72 13.7151481068331 3.14447237675643 0.793323368934293 +244.08 13.7160478999666 3.14447348914476 0.794080027851569 +250.96 13.7169476934199 3.14447460075431 0.822665883734586 +261.16 13.7178474871927 3.1444757115851 0.810905423620337 +245.96 13.7187472812848 3.14447682163712 0.814932251114646 +248.18 13.7196470756961 3.14447793091037 0.810386507577471 +241.81 13.7205468704262 3.14447903940484 0.810553207503474 +241.27 13.7214466654751 3.14448014712054 0.817400042717535 +245.56 13.7223464608423 3.14448125405746 0.824747389976166 +244.44 13.7232462565278 3.1444823602156 0.830036362428811 +259.31 13.7241460525313 3.14448346559497 0.825907294837486 +259.57 13.7250458488525 3.14448457019555 0.80879625366675 +267.46 13.7259456454913 3.14448567401736 0.792291087647671 +277.55 13.7268454424474 3.14448677706037 0.750315819744811 +260.99 13.7277452397206 3.14448787932461 0.772152636390456 +258.59 13.7286450373107 3.14448898081006 0.798575237159433 +253.43 13.7295448352175 3.14449008151672 0.808481590209741 +254.59 13.7304446334406 3.1444911814446 0.820403739877895 +261.65 13.73134443198 3.14449228059369 0.81289328581459 +249.06 13.7322442308353 3.14449337896398 0.803857839327351 +246.49 13.7331440300064 3.14449447655548 0.836237434325343 +242.78 13.734043829493 3.14449557336819 0.822715711143771 +243.75 13.734943629295 3.1444966694021 0.831118353829423 +242.13 13.735843429412 3.14449776465722 0.819287019133184 +239.53 13.7367432298439 3.14449885913354 0.825917179052355 +230.24 13.7376430305904 3.14449995283106 0.822771233475484 +230.88 13.7385428316513 3.14450104574977 0.81565849256119 +229.53 13.7394426330264 3.14450213788969 0.823879471579274 +230.29 13.7403424347155 3.1445032292508 0.832769845483249 +242.07 13.7412422367183 3.14450431983311 0.823254018741021 +235.95 13.7421420390346 3.14450540963661 0.820394612743804 +255.71 13.7430418416642 3.14450649866131 0.818794251664914 +239.69 13.7439416446069 3.1445075869072 0.810289414647341 +231.32 13.7448414478624 3.14450867437427 0.810980366923776 +228.57 13.7457412514306 3.14450976106254 0.819226980355798 +228.85 13.7466410553111 3.14451084697199 0.820262467998739 +239.68 13.7475408595038 3.14451193210263 0.822091040753845 +241.43 13.7484406640085 3.14451301645445 0.815249368894318 +243.62 13.7493404688248 3.14451410002746 0.829960640324891 +246.67 13.7502402739527 3.14451518282165 0.819333407615811 +249.77 13.7511400793919 3.14451626483702 0.824818809156982 +252.99 13.7520398851421 3.14451734607357 0.809109010376839 +262.07 13.7529396912031 3.14451842653129 0.805438645304669 +258.21 13.7538394975748 3.1445195062102 0.797098814143008 +264.05 13.7547393042568 3.14452058511028 0.793501879636837 +257.75 13.7556391112489 3.14452166323153 0.790770715770716 +251.74 13.756538918551 3.14452274057395 0.79935807691162 +262.14 13.7574387261628 3.14452381713755 0.819279600755049 +272.74 13.7583385340841 3.14452489292232 0.804770682212326 +270.48 13.7592383423147 3.14452596792825 0.789401972690382 +263.78 13.7601381508543 3.14452704215535 0.807364550973295 +250.58 13.7610379597027 3.14452811560362 0.807336141295256 +237.82 13.7619377688597 3.14452918827306 0.79598440593355 +236.09 13.762837578325 3.14453026016365 0.797416372946731 +237.95 13.7637373880985 3.14453133127541 0.806259952733035 +237.59 13.7646371981799 3.14453240160833 0.815791164476494 +241.38 13.765537008569 3.14453347116241 0.794282142387156 +248.13 13.7664368192655 3.14453453993765 0.793770538422649 +251.95 13.7673366302694 3.14453560793404 0.802060715233372 +252.04 13.7682364415802 3.14453667515159 0.80235792019347 +254.02 13.7691362531978 3.14453774159029 0.814544977418063 +264.44 13.770036065122 3.14453880725015 0.804486004155971 +263.83 13.7709358773525 3.14453987213116 0.800014005137674 +263.9 13.7718356898892 3.14454093623332 0.79284231280527 +269.2 13.7727355027318 3.14454199955662 0.795818597137916 +297.06 13.77363531588 3.14454306210108 0.805903981510663 +282.31 13.7745351293337 3.14454412386668 0.800936877076412 +271.1 13.7754349430926 3.14454518485342 0.79882898082689 +288.42 13.7763347571565 3.14454624506131 0.72139977121818 +269.18 13.7772345715252 3.14454730449034 0.777478568247606 +267.48 13.7781343861985 3.14454836314052 0.783679172056921 +278.84 13.7790342011761 3.14454942101183 0.789250880298942 +292.09 13.7799340164578 3.14455047810428 0.78965250581538 +299.17 13.7808338320434 3.14455153441787 0.796403533610687 +290.29 13.7817336479326 3.14455258995259 0.803270676691729 +305.61 13.7826334641253 3.14455364470845 0.796774084676442 +294.97 13.7835332806212 3.14455469868544 0.792839299538939 +272.37 13.7844330974201 3.14455575188356 0.810771266867514 +263.24 13.7853329145217 3.14455680430282 0.802264244293915 +265.36 13.7862327319259 3.1445578559432 0.808268949676342 +275.21 13.7871325496324 3.14455890680471 0.806349326902994 +279.86 13.788032367641 3.14455995688735 0.745918417799753 +254.16 13.7889321859514 3.14456100619112 0.806834730725183 +259.88 13.7898320045635 3.144562054716 0.817112346332371 +259.92 13.7907318234771 3.14456310246201 0.802888462297494 +269.05 13.7916316426918 3.14456414942915 0.813350156536759 +260.98 13.7925314622075 3.1445651956174 0.795630009543836 +258.02 13.7934312820239 3.14456624102677 0.799536678351986 +260.91 13.7943311021409 3.14456728565726 0.800546958477483 +260.09 13.7952309225581 3.14456832950886 0.80286313956791 +259.22 13.7961307432755 3.14456937258159 0.810447435328586 +257.03 13.7970305642927 3.14457041487542 0.800907400632842 +246.27 13.7979303856095 3.14457145639037 0.798955149044916 +238.36 13.7988302072257 3.14457249712642 0.81093806869337 +238.21 13.7997300291411 3.14457353708359 0.815960893494023 +256.52 13.8006298513555 3.14457457626187 0.809452561798879 +249.26 13.7115500474574 3.14356344564972 0.804189057373415 +240.07 13.7124498385349 3.14356456083163 0.813248660797765 +247.7 13.713349629933 3.14356567523499 0.825962891017483 +242.6 13.7142494216516 3.14356678885982 0.821181874757171 +242.35 13.7151492136905 3.1435679017061 0.82033527696793 +245.49 13.7160490060493 3.14356901377384 0.80730384724114 +240.28 13.716948798728 3.14357012506304 0.816317913433518 +257.25 13.7178485917261 3.14357123557369 0.797451763453552 +250.75 13.7187483850437 3.1435723453058 0.798064741200448 +244.88 13.7196481786803 3.14357345425936 0.807757545884195 +241.16 13.7205479726358 3.14357456243437 0.81567348158478 +235.15 13.72144776691 3.14357566983083 0.819813059359723 +241.96 13.7223475615026 3.14357677644874 0.821144970634946 +238 13.7232473564135 3.14357788228809 0.834628004979422 +243.63 13.7241471516423 3.14357898734889 0.843325657582376 +245.23 13.7250469471889 3.14358009163114 0.836766147802633 +251.06 13.7259467430531 3.14358119513482 0.819305773023975 +253.6 13.7268465392346 3.14358229785995 0.825505337121038 +257.52 13.7277463357331 3.14358339980652 0.818573162980127 +248.09 13.7286461325486 3.14358450097453 0.832962395955282 +237.78 13.7295459296807 3.14358560136398 0.842929190046729 +255.56 13.7304457271292 3.14358670097486 0.831252113536874 +253.84 13.7313455248939 3.14358779980717 0.823498512772752 +242.67 13.7322453229746 3.14358889786092 0.823166326046118 +254.72 13.733145121371 3.14358999513611 0.812863076171345 +240.36 13.734044920083 3.14359109163272 0.820927495789555 +244.9 13.7349447191103 3.14359218735076 0.834475638782943 +239.46 13.7358445184527 3.14359328229023 0.830829025116985 +242.38 13.7367443181099 3.14359437645112 0.83074116971737 +231.9 13.7376441180817 3.14359546983344 0.827339472597699 +230.68 13.738543918368 3.14359656243719 0.825570459478692 +230.11 13.7394437189685 3.14359765426236 0.832322227045417 +233.52 13.7403435198829 3.14359874530895 0.831064840494375 +243.25 13.741243321111 3.14359983557696 0.818487602974849 +253.3 13.7421431226527 3.14360092506638 0.79975577231387 +256.01 13.7430429245076 3.14360201377723 0.798333734126646 +231.45 13.7439427266756 3.14360310170949 0.806769780722072 +230.77 13.7448425291565 3.14360418886316 0.816799028161936 +231.04 13.74574233195 3.14360527523825 0.820167201793179 +234.02 13.7466421350558 3.14360636083475 0.826588546862813 +235.38 13.7475419384739 3.14360744565266 0.817700309962439 +237.9 13.7484417422039 3.14360852969198 0.819687347516794 +239.92 13.7493415462456 3.1436096129527 0.826842706847803 +241.57 13.7502413505988 3.14361069543484 0.817326255723899 +264.02 13.7511411552633 3.14361177713837 0.812402789453443 +256.23 13.7520409602388 3.14361285806332 0.814177853822722 +248.62 13.7529407655251 3.14361393820966 0.817887392315551 +249.09 13.7538405711221 3.14361501757741 0.810600282664565 +252.91 13.7547403770294 3.14361609616655 0.811359667718222 +257.5 13.7556401832469 3.1436171739771 0.814716940009808 +255.14 13.7565399897743 3.14361825100904 0.818217051628125 +256.11 13.7574397966115 3.14361932726237 0.821165913231226 +252.49 13.7583396037581 3.1436204027371 0.814788302790306 +247.93 13.7592394112139 3.14362147743323 0.805954583171565 +250.14 13.7601392189788 3.14362255135074 0.813896892117303 +240.32 13.7610390270525 3.14362362448965 0.803851628975379 +235.79 13.7619388354348 3.14362469684995 0.796644623637775 +232.52 13.7628386441255 3.14362576843163 0.808283321242498 +238.91 13.7637384531243 3.1436268392347 0.803070544794973 +230.55 13.764638262431 3.14362790925916 0.810468475702399 +246.01 13.7655380720454 3.14362897850499 0.799501441518931 +244.12 13.7664378819672 3.14363004697222 0.801816801932966 +251.06 13.7673376921963 3.14363111466082 0.798937043260776 +263.54 13.7682375027325 3.1436321815708 0.791333333333333 +264.33 13.7691373135754 3.14363324770216 0.805753332680552 +259.94 13.7700371247249 3.1436343130549 0.793275600529964 +262.31 13.7709369361807 3.14363537762902 0.785997327380447 +246.71 13.7718367479427 3.14363644142451 0.79911810672025 +267.73 13.7727365600105 3.14363750444137 0.801462165504244 +290 13.7736363723841 3.1436385666796 0.795288859581639 +286.89 13.7745361850631 3.14363962813921 0.805720401130799 +260.36 13.7754359980473 3.14364068882018 0.801925130571379 +258.67 13.7763358113365 3.14364174872253 0.795006687141793 +256.74 13.7772356249305 3.14364280784624 0.765262048883653 +263.15 13.778135438829 3.14364386619131 0.778359976317347 +272.62 13.7790352530319 3.14364492375775 0.803486051775168 +286.83 13.7799350675389 3.14364598054555 0.796081304957308 +284.29 13.7808348823497 3.14364703655472 0.797741101663784 +282.63 13.7817346974643 3.14364809178524 0.808769986781036 +295.56 13.7826345128822 3.14364914623713 0.793471763564562 +288.4 13.7835343286034 3.14365019991037 0.798937069142706 +267.52 13.7844341446275 3.14365125280496 0.815043384844228 +259.04 13.7853339609544 3.14365230492092 0.808447335829288 +256.57 13.7862337775839 3.14365335625822 0.811005791045613 +254.75 13.7871335945157 3.14365440681688 0.816600812129995 +263.55 13.7880334117495 3.14365545659689 0.803246024353712 +269.57 13.7889332292853 3.14365650559825 0.750630038568107 +269.77 13.7898330471226 3.14365755382096 0.819076586582824 +262.01 13.7907328652614 3.14365860126501 0.820116327624358 +268.17 13.7916326837014 3.14365964793042 0.803397071148943 +260.49 13.7925325024424 3.14366069381716 0.827326217438869 +259.18 13.7934323214841 3.14366173892525 0.819700885304771 +254.2 13.7943321408263 3.14366278325468 0.811455386754914 +257.36 13.7952319604688 3.14366382680546 0.813474846713758 +263.98 13.7961317804114 3.14366486957757 0.800890239137658 +248.2 13.7970316006539 3.14366591157102 0.819882289390157 +251.67 13.797931421196 3.14366695278581 0.814386443474077 +241.96 13.7988312420374 3.14366799322193 0.826698778961539 +250.9 13.7997310631781 3.14366903287939 0.82004831753899 +250.89 13.8006308846177 3.14367007175818 0.809300062975854 +245.9 13.7115511570924 3.14265897186788 0.801268052643839 +245.97 13.7124509473954 3.1426600867283 0.822049346312968 +246.32 13.7133507380192 3.14266120081041 0.813254483789377 +237.71 13.7142505289634 3.1426623141142 0.819491201637843 +244.59 13.7151503202278 3.14266342663968 0.814749198804508 +234.32 13.7160501118123 3.14266453838683 0.815309493034611 +243.34 13.7169499037165 3.14266564935567 0.819537826995876 +251.35 13.7178496959403 3.14266675954619 0.813956780053857 +241.89 13.7187494884834 3.14266786895839 0.813351087700196 +240.75 13.7196492813456 3.14266897759226 0.807341190831513 +235.75 13.7205490745267 3.14267008544781 0.8071761792317 +234.8 13.7214488680265 3.14267119252503 0.811240589553338 +237.29 13.7223486618448 3.14267229882393 0.825736175535519 +233.74 13.7232484559812 3.14267340434449 0.818840284842319 +237.83 13.7241482504356 3.14267450908673 0.826871389292224 +251.2 13.7250480452078 3.14267561305063 0.819932647182137 +262.73 13.7259478402976 3.14267671623621 0.827651390880771 +242.45 13.7268476357046 3.14267781864345 0.822354859978485 +246.96 13.7277474314288 3.14267892027235 0.819582603289437 +251.24 13.7286472274698 3.14268002112292 0.827427645740688 +248.87 13.7295470238275 3.14268112119515 0.848619237725984 +252.21 13.7304468205016 3.14268222048903 0.833872016433761 +243.21 13.7313466174919 3.14268331900458 0.821497937011677 +239.6 13.7322464147981 3.14268441674179 0.831334563345633 +237.76 13.7331462124202 3.14268551370065 0.831492717029842 +235.56 13.7340460103577 3.14268660988117 0.832435515991624 +245.98 13.7349458086106 3.14268770528334 0.8137384551908 +240.76 13.7358456071785 3.14268879990716 0.817065068139202 +234.14 13.7367454060613 3.14268989375263 0.83589221211776 +224.11 13.7376452052587 3.14269098681976 0.821121438827174 +229.91 13.7385450047705 3.14269207910853 0.829235310368895 +232.15 13.7394448045966 3.14269317061895 0.821562108206264 +232.05 13.7403446047365 3.14269426135101 0.821609645468505 +240.98 13.7412444051902 3.14269535130472 0.810122756884752 +244.42 13.7421442059575 3.14269644048007 0.795599975117673 +250.2 13.743044007038 3.14269752887707 0.794118255245059 +241.89 13.7439438084315 3.1426986164957 0.801647558112328 +239.08 13.744843610138 3.14269970333597 0.806163325718331 +230.94 13.745743412157 3.14270078939788 0.815292524208363 +229.08 13.7466432144884 3.14270187468143 0.827519039250146 +236.17 13.747543017132 3.14270295918661 0.821717881520528 +236.29 13.7484428200875 3.14270404291343 0.825669706003961 +238.19 13.7493426233548 3.14270512586188 0.822207614352232 +240.75 13.7502424269336 3.14270620803195 0.824854814989749 +244.73 13.7511422308236 3.14270728942366 0.810810610055932 +253.44 13.7520420350247 3.142708370037 0.806996471455459 +246.49 13.7529418395366 3.14270944987196 0.815537639573465 +241.87 13.7538416443591 3.14271052892855 0.809462614991616 +241.97 13.7547414494919 3.14271160720676 0.816377831667357 +235.83 13.755641254935 3.1427126847066 0.820006909951445 +243.23 13.7565410606879 3.14271376142805 0.813540774044686 +246.85 13.7574408667506 3.14271483737113 0.820492511262674 +250.09 13.7583406731227 3.14271591253583 0.80298239111749 +242.96 13.7592404798041 3.14271698692214 0.811702664533267 +242.6 13.7601402867946 3.14271806053007 0.810725771538129 +243.36 13.7610400940938 3.14271913335961 0.809781069933655 +235.21 13.7619399017016 3.14272020541077 0.802208084614003 +240.78 13.7628397096178 3.14272127668354 0.804991437233531 +237.98 13.7637395178421 3.14272234717793 0.804257904139207 +237.49 13.7646393263744 3.14272341689392 0.819662218750352 +240.82 13.7655391352143 3.14272448583152 0.810009813542689 +244.05 13.7664389443617 3.14272555399072 0.805928694269138 +251.42 13.7673387538163 3.14272662137154 0.800847524502454 +255.95 13.768238563578 3.14272768797395 0.799383315166266 +263.49 13.7691383736464 3.14272875379797 0.792638803167998 +254.19 13.7700381840214 3.1427298188436 0.813745736781763 +250.03 13.7709379947028 3.14273088311082 0.811920213103791 +249.93 13.7718378056903 3.14273194659964 0.818758797370106 +266.83 13.7727376169836 3.14273300931006 0.834746339591817 +269.59 13.7736374285827 3.14273407124207 0.823381311136374 +269.4 13.7745372404872 3.14273513239568 0.835028491817198 +263.03 13.7754370526969 3.14273619277089 0.830362403539 +270.87 13.7763368652116 3.14273725236769 0.813523196819917 +251.28 13.7772366780311 3.14273831118607 0.801401493394601 +256.7 13.7781364911552 3.14273936922605 0.825042676170226 +268.3 13.7790363045836 3.14274042648762 0.825167129944725 +268.58 13.7799361183161 3.14274148297077 0.814532429994535 +271.77 13.7808359323524 3.14274253867551 0.796091198204432 +275.85 13.7817357466924 3.14274359360184 0.782083370578946 +276.36 13.7826355613359 3.14274464774975 0.793188343382142 +280.69 13.7835353762826 3.14274570111924 0.821084967557402 +259.33 13.7844351915322 3.14274675371031 0.813254196932314 +252.63 13.7853350070847 3.14274780552296 0.797363885535537 +244.88 13.7862348229396 3.14274885655719 0.813429668963125 +247.96 13.7871346390969 3.142749906813 0.807717115277588 +246.57 13.7880344555562 3.14275095629038 0.836665100606408 +285.04 13.7889342723175 3.14275200498934 0.735240139664619 +301.35 13.7898340893803 3.14275305290987 0.71641508619688 +277.23 13.7907339067446 3.14275410005197 0.796572466534163 +271.43 13.7916337244101 3.14275514641564 0.813418870225442 +275.31 13.7925335423765 3.14275619200088 0.80383121540606 +258.52 13.7934333606437 3.14275723680769 0.809143540187508 +260.39 13.7943331792114 3.14275828083607 0.806926478459378 +261.37 13.7952329980794 3.14275932408601 0.807440656515862 +261.45 13.7961328172475 3.14276036655751 0.819080403751969 +248.48 13.7970326367154 3.14276140825058 0.820861320467135 +238.54 13.797932456483 3.14276244916521 0.807257719998903 +242.48 13.79883227655 3.1427634893014 0.801592984432198 +249.14 13.7997320969161 3.14276452865915 0.805386265363794 +251.45 13.8006319175812 3.14276556723845 0.800224685032789 +234.19 13.7115522664064 3.14175449806995 0.808371794420109 +236.76 13.7124520559353 3.14175561260889 0.820359592793288 +239.28 13.7133518457849 3.14175672636974 0.798794096543632 +238.74 13.7142516359549 3.1417578393525 0.818914424117956 +237.28 13.7151514264451 3.14175895155717 0.814773390947853 +233.64 13.7160512172554 3.14176006298374 0.813523245701033 +236.86 13.7169510083855 3.14176117363222 0.815338387948462 +236.15 13.7178507998351 3.14176228350261 0.823107639714952 +237.66 13.718750591604 3.14176339259489 0.810838859340542 +233.78 13.7196503836921 3.14176450090908 0.82183626304363 +234.51 13.720550176099 3.14176560844517 0.810683971709521 +231.09 13.7214499688246 3.14176671520315 0.81437999358377 +229.02 13.7223497618686 3.14176782118304 0.81824105468528 +237.63 13.7232495552309 3.14176892638482 0.808225613359802 +235.49 13.7241493489111 3.14177003080849 0.809374818935048 +237.46 13.7250491429091 3.14177113445405 0.820697954271961 +240.04 13.7259489372247 3.14177223732151 0.8249774863511 +234.62 13.7268487318576 3.14177333941086 0.816703027663146 +247.87 13.7277485268075 3.1417744407221 0.809923747674122 +256.59 13.7286483220744 3.14177554125522 0.80944928238777 +264.3 13.7295481176578 3.14177664101024 0.845299651264901 +257.81 13.7304479135577 3.14177773998713 0.833652837225332 +253.57 13.7313477097738 3.14177883818591 0.807395956112524 +255.74 13.7322475063059 3.14177993560657 0.811286272273503 +245.78 13.7331473031537 3.14178103224912 0.834852414003509 +249.34 13.7340471003171 3.14178212811354 0.809625219223911 +243.14 13.7349468977957 3.14178322319984 0.815787008682495 +241.02 13.7358466955895 3.14178431750802 0.815311520955252 +234.47 13.736746493698 3.14178541103807 0.822113582062121 +235.44 13.7376462921213 3.14178650379 0.820035395071459 +227.8 13.7385460908589 3.1417875957638 0.81767019573092 +233.47 13.7394458899107 3.14178868695947 0.830569267630842 +239.55 13.7403456892764 3.14178977737701 0.828480466936393 +240.33 13.7412454889559 3.14179086701642 0.801773686397817 +246.06 13.742145288949 3.1417919558777 0.795059722109369 +241.84 13.7430450892553 3.14179304396084 0.792252105940927 +242.56 13.7439448898746 3.14179413126585 0.807103783034132 +231.53 13.7448446908068 3.14179521779272 0.815072782244897 +229.52 13.7457444920516 3.14179630354145 0.826559579809676 +227.77 13.7466442936088 3.14179738851205 0.825967048037724 +231.61 13.7475440954782 3.1417984727045 0.814315215273719 +240.33 13.7484438976595 3.14179955611881 0.810856166473424 +241.11 13.7493437001525 3.14180063875498 0.818591748543893 +235.86 13.7502435029571 3.14180172061301 0.813444514516619 +235.02 13.7511433060729 3.14180280169288 0.815863013910714 +245.2 13.7520431094997 3.14180388199461 0.809175608519659 +238.95 13.7529429132374 3.1418049615182 0.807845131012906 +231.59 13.7538427172857 3.14180604026363 0.811692365683861 +237.54 13.7547425216443 3.14180711823091 0.81224483624157 +238.26 13.7556423263131 3.14180819542003 0.812679113528044 +225.1 13.7565421312918 3.14180927183101 0.809625818252226 +238.68 13.7574419365802 3.14181034746383 0.808041800074643 +245.43 13.7583417421781 3.14181142231849 0.806081894425259 +243.15 13.7592415480853 3.14181249639499 0.802742886945802 +240.53 13.7601413543015 3.14181356969334 0.818557906500004 +242.38 13.7610411608265 3.14181464221352 0.81779980238426 +229.69 13.7619409676601 3.14181571395554 0.815706070640612 +237.48 13.762840774802 3.1418167849194 0.819867863823992 +237 13.7637405822521 3.1418178551051 0.814504844428433 +240.01 13.7646403900101 3.14181892451262 0.815183697009019 +245.37 13.7655401980758 3.14181999314198 0.806453567182376 +255.37 13.7664400064489 3.14182106099318 0.800140247109309 +255.01 13.7673398151293 3.1418221280662 0.805478394193967 +274.99 13.7682396241167 3.14182319436105 0.767453621924314 +252.78 13.7691394334109 3.14182425987773 0.805789932536846 +250.21 13.7700392430116 3.14182532461624 0.816029681088501 +246.96 13.7709390529187 3.14182638857656 0.805240133664102 +245.77 13.771838863132 3.14182745175872 0.80753917508064 +257.41 13.7727386736511 3.14182851416269 0.816430474913083 +277.53 13.7736384844759 3.14182957578849 0.804680836775125 +269.21 13.7745382956061 3.14183063663611 0.830840796717534 +268.82 13.7754381070415 3.14183169670554 0.843555438564366 +265.04 13.776337918782 3.14183275599679 0.822106488105458 +243.7 13.7772377308272 3.14183381450986 0.826031811680367 +246.28 13.778137543177 3.14183487224474 0.809171806232791 +250.76 13.7790373558311 3.14183592920144 0.815248436632084 +251.55 13.7799371687894 3.14183698537995 0.808936665850601 +254 13.7808369820515 3.14183804078026 0.807961128484978 +264.04 13.7817367956172 3.14183909540239 0.805197387105936 +266.5 13.7826366094864 3.14184014924632 0.80190645247182 +257.22 13.7835364236588 3.14184120231207 0.803878766920977 +253.81 13.7844362381342 3.14184225459961 0.805534273068769 +252.91 13.7853360529123 3.14184330610896 0.816857714119011 +252.03 13.786235867993 3.14184435684012 0.810345442993696 +248.18 13.787135683376 3.14184540679307 0.812521404577483 +243.24 13.7880354990611 3.14184645596783 0.815216514501522 +266.66 13.788935315048 3.14184750436438 0.805129016416676 +340.54 13.7898351313366 3.14184855198273 0.620846821895949 +342.71 13.7907349479266 3.14184959882288 0.596222592039332 +331.26 13.7916347648178 3.14185064488482 0.647531475798072 +321.16 13.7925345820099 3.14185169016856 0.702018627489186 +286.13 13.7934343995028 3.14185273467409 0.80511047847147 +265.2 13.7943342172962 3.14185377840141 0.811810775988881 +261.45 13.79523403539 3.14185482135051 0.810294384974465 +253.92 13.7961338537838 3.14185586352141 0.804313613143982 +245.33 13.7970336724774 3.1418569049141 0.813958251049575 +240.44 13.7979334914707 3.14185794552857 0.822117256613015 +252.1 13.7988333107633 3.14185898536482 0.805573946791816 +259.33 13.7997331303552 3.14186002442286 0.792034559854485 +268.72 13.8006329502459 3.14186106270268 0.798378071126206 +230.58 13.7115533753995 3.14085002425594 0.822657537256051 +234.23 13.7124531641544 3.1408511384734 0.819533961328706 +236.07 13.7133529532301 3.14085225191299 0.816459739881262 +238.13 13.7142527426262 3.14085336457472 0.811555304421528 +227.73 13.7151525323425 3.14085447645858 0.816058985949535 +234.03 13.7160523223788 3.14085558756457 0.807693068954188 +240.54 13.7169521127349 3.14085669789269 0.81700119821087 +239.46 13.7178519034105 3.14085780744294 0.820546211283892 +241.46 13.7187516944055 3.14085891621532 0.81708808173602 +237.88 13.7196514857196 3.14086002420982 0.814638926579225 +234.17 13.7205512773526 3.14086113142645 0.818181145834489 +229.32 13.7214510693042 3.1408622378652 0.823690136616124 +230.59 13.7223508615743 3.14086334352607 0.817083829956297 +235.87 13.7232506541626 3.14086444840906 0.813475992239155 +234.6 13.7241504470689 3.14086555251417 0.810354754075557 +241.27 13.7250502402929 3.1408666558414 0.810633749927786 +242.87 13.7259500338345 3.14086775839074 0.809542901450536 +245.38 13.7268498276934 3.1408688601622 0.811287249447451 +250.32 13.7277496218694 3.14086996115577 0.797278712728445 +255.48 13.7286494163623 3.14087106137146 0.797846786855882 +255.98 13.7295492111718 3.14087216080925 0.823274539244642 +259.06 13.7304490062977 3.14087325946916 0.82375702436769 +253.68 13.7313488017398 3.14087435735117 0.813045800414791 +250.1 13.7322485974979 3.14087545445529 0.813763081072776 +250.68 13.7331483935718 3.14087655078152 0.822638940884185 +237.61 13.7340481899611 3.14087764632984 0.814316626056569 +236.62 13.7349479866658 3.14087874110027 0.811521382625821 +243.6 13.7358477836856 3.14087983509281 0.814630761390866 +238.46 13.7367475810202 3.14088092830744 0.810816234012352 +228.85 13.7376473786694 3.14088202074417 0.812765924347197 +224.39 13.738547176633 3.140883112403 0.826608252854674 +237.59 13.7394469749109 3.14088420328392 0.830294544664503 +237.77 13.7403467735026 3.14088529338694 0.809948305571511 +230.82 13.7412465724081 3.14088638271205 0.812269400531913 +232.77 13.7421463716272 3.14088747125925 0.807352150756552 +240.39 13.7430461711595 3.14088855902855 0.79778985684671 +245.68 13.7439459710048 3.14088964601993 0.800826665833229 +228.68 13.744845771163 3.1408907322334 0.819985497631794 +226.87 13.7457455716339 3.14089181766896 0.813682110184916 +229.94 13.7466453724171 3.1408929023266 0.814602533881001 +230.87 13.7475451735124 3.14089398620633 0.816872483273002 +241.98 13.7484449749197 3.14089506930814 0.802955937780555 +231.75 13.7493447766388 3.14089615163203 0.811898439763603 +233.1 13.7502445786693 3.140897233178 0.812666739472986 +233 13.7511443810111 3.14089831394605 0.817321665755137 +235.68 13.7520441836639 3.14089939393617 0.820739063457006 +234.73 13.7529439866276 3.14090047314837 0.811822498516135 +244.82 13.7538437899019 3.14090155158265 0.822182818753069 +243.68 13.7547435934865 3.14090262923899 0.807238475316595 +239.12 13.7556433973813 3.14090370611742 0.809652231176895 +229.31 13.756543201586 3.14090478221791 0.80893092687321 +245.19 13.7574430061004 3.14090585754047 0.816638332956361 +242.85 13.7583428109243 3.14090693208509 0.81319512176681 +239.19 13.7592426160574 3.14090800585179 0.803156902718028 +235.68 13.7601424214996 3.14090907884055 0.821622023256678 +244.63 13.7610422272506 3.14091015105137 0.800584184614902 +229.02 13.7619420333102 3.14091122248426 0.815497891200229 +238.27 13.7628418396781 3.1409122931392 0.813827401421141 +241.19 13.7637416463541 3.14091336301621 0.811224529042084 +242.67 13.7646414533381 3.14091443211528 0.812133860991678 +251.63 13.7655412606298 3.1409155004364 0.816871901198954 +247.23 13.7664410682289 3.14091656797958 0.80733464712403 +245.69 13.7673408761352 3.14091763474481 0.802998043390463 +251.75 13.7682406843486 3.1409187007321 0.77684986134531 +242.45 13.7691404928688 3.14091976594143 0.816640793413724 +254.35 13.7700403016955 3.14092083037282 0.810800547994163 +252.81 13.7709401108286 3.14092189402626 0.813671973810109 +243.57 13.7718399202677 3.14092295690175 0.818475447432655 +252.47 13.7727397300128 3.14092401899928 0.809782159469187 +267.59 13.7736395400636 3.14092508031886 0.805309673074653 +249.29 13.7745393504198 3.14092614086048 0.827568035024187 +255.01 13.7754391610812 3.14092720062415 0.841887224611033 +262.47 13.7763389720476 3.14092825960986 0.837562699363223 +257.81 13.7772387833188 3.1409293178176 0.831839853595107 +243.81 13.7781385948945 3.14093037524739 0.816012186252836 +239.56 13.7790384067746 3.14093143189921 0.803137267192679 +244.71 13.7799382189588 3.14093248777307 0.816740361263462 +252.97 13.7808380314468 3.14093354286897 0.826788570173452 +254.82 13.7817378442385 3.1409345971869 0.815693129956941 +252.43 13.7826376573337 3.14093565072686 0.796056761553425 +259.6 13.783537470732 3.14093670348885 0.799951695561275 +265.28 13.7844372844334 3.14093775547287 0.801835900113112 +248.69 13.7853370984374 3.14093880667892 0.804737594903145 +239.78 13.7862369127441 3.140939857107 0.815722845029921 +243.57 13.787136727353 3.1409409067571 0.807107064988716 +249.39 13.788036542264 3.14094195562923 0.815349513897162 +259.22 13.7889363574769 3.14094300372338 0.825257083672413 +268.31 13.7898361729914 3.14094405103956 0.810573421091313 +282.27 13.7907359888074 3.14094509757775 0.79140905835014 +304.68 13.7916358049245 3.14094614333796 0.731077447352307 +318.32 13.7925356213426 3.1409471883202 0.70324055653448 +303.74 13.7934354380614 3.14094823252444 0.720064330620401 +274.27 13.7943352550808 3.14094927595071 0.801800210635111 +278.16 13.7952350724004 3.14095031859899 0.8005439101844 +256.61 13.7961348900201 3.14095136046928 0.803983979016765 +262.39 13.7970347079397 3.14095240156158 0.817574311698427 +271.66 13.7979345261589 3.14095344187589 0.819285692350214 +278.58 13.7988343446775 3.14095448141222 0.777443370822113 +281.53 13.7997341634953 3.14095552017055 0.744257838764016 +272.48 13.800633982612 3.14095655815088 0.773071769231878 +232.68 13.7115544840717 3.13994555042585 0.819017207087203 +237.45 13.7124542720529 3.13994666432182 0.80175316608983 +237.5 13.7133540603548 3.13994777744016 0.806424315886974 +231.5 13.7142538489772 3.13994888978086 0.812503105708771 +229.77 13.7151536379198 3.13995000134391 0.818327676175989 +231.86 13.7160534271824 3.13995111212932 0.820012888336056 +229.16 13.7169532167648 3.13995222213708 0.828074193145869 +232.27 13.7178530066667 3.1399533313672 0.823304775556617 +236.21 13.7187527968879 3.13995443981967 0.805639519990542 +240.52 13.7196525874283 3.13995554749449 0.814286902538432 +238.81 13.7205523782875 3.13995665439165 0.821343541051851 +238.72 13.7214521694655 3.13995776051117 0.81939087154662 +236.01 13.7223519609618 3.13995886585303 0.82066731501861 +240.93 13.7232517527763 3.13995997041723 0.816104807891696 +241 13.7241515449089 3.13996107420378 0.818166098690894 +239.49 13.7250513373592 3.13996217721267 0.830435651128642 +240.78 13.725951130127 3.1399632794439 0.809658067926726 +247.75 13.7268509232122 3.13996438089747 0.797459529446015 +237.53 13.7277507166144 3.13996548157338 0.813101814091389 +248.38 13.7286505103335 3.13996658147162 0.799066826051749 +254.8 13.7295503043693 3.1399676805922 0.800879619264962 +255.88 13.7304500987215 3.13996877893512 0.805728839578536 +273.55 13.7313498933899 3.13996987650036 0.789886709811464 +251.82 13.7322496883742 3.13997097328794 0.824970996729349 +243.15 13.7331494836743 3.13997206929785 0.828401271849397 +227.43 13.7340492792899 3.13997316453008 0.823831895067693 +228.57 13.7349490752208 3.13997425898464 0.822454327755772 +237.01 13.7358488714668 3.13997535266153 0.820558109286548 +237.25 13.7367486680277 3.13997644556074 0.821478443650689 +222.58 13.7376484649031 3.13997753768228 0.823276384345087 +233.4 13.738548262093 3.13997862902613 0.829649414739007 +238.75 13.7394480595971 3.13997971959231 0.815410070319257 +221.84 13.7403478574151 3.13998080938081 0.806165978347695 +235.3 13.7412476555468 3.13998189839162 0.814896998640981 +240.65 13.7421474539921 3.13998298662475 0.801731664143659 +244.87 13.7430472527506 3.1399840740802 0.802162277800007 +245.02 13.7439470518222 3.13998516075795 0.794552796351093 +236.1 13.7448468512067 3.13998624665802 0.814778475576002 +236.32 13.7457466509037 3.13998733178041 0.812733021147135 +232.85 13.7466464509131 3.1399884161251 0.817084468770472 +235.12 13.7475462512347 3.1399894996921 0.816796306122219 +234.22 13.7484460518683 3.1399905824814 0.810156719522907 +229.01 13.7493458528135 3.13999166449301 0.81817972624175 +232.23 13.7502456540703 3.13999274572693 0.816981537140404 +237.99 13.7511454556383 3.13999382618315 0.829133308258557 +247.53 13.7520452575173 3.13999490586167 0.818997992537555 +241.32 13.7529450597072 3.13999598476249 0.814586539544311 +232.4 13.7538448622077 3.13999706288561 0.799935254127549 +243.53 13.7547446650186 3.13999814023103 0.799793372009855 +236.8 13.7556444681396 3.13999921679874 0.796349616301917 +231.41 13.7565442715705 3.14000029258875 0.806350472695361 +247.22 13.7574440753111 3.14000136760105 0.821546156324866 +244.34 13.7583438793612 3.14000244183565 0.82238368150966 +235.87 13.7592436837206 3.14000351529253 0.819872824105783 +241.15 13.7601434883889 3.14000458797171 0.821063849002077 +233.21 13.7610432933661 3.14000565987317 0.81175912939083 +227.14 13.7619430986519 3.14000673099692 0.816558863616668 +235.9 13.762842904246 3.14000780134296 0.809603072983355 +239.75 13.7637427101483 3.14000887091128 0.810879195371494 +239.42 13.7646425163584 3.14000993970188 0.803848150525064 +241.81 13.7655423228763 3.14001100771476 0.816828955988327 +240.93 13.7664421297016 3.14001207494993 0.806909374056476 +243.45 13.7673419368342 3.14001314140737 0.809623510892738 +244.5 13.7682417442737 3.1400142070871 0.804700338418363 +243.28 13.7691415520201 3.14001527198909 0.818772682530976 +247.86 13.770041360073 3.14001633611337 0.807059613822408 +248.71 13.7709411684323 3.14001739945991 0.815537863358637 +250.23 13.7718409770976 3.14001846202873 0.808799670866227 +255.48 13.7727407860689 3.14001952381983 0.815654972922421 +259.58 13.7736405953458 3.14002058483319 0.798516017969103 +247.44 13.7745404049282 3.14002164506882 0.830435611062268 +243.69 13.7754402148158 3.14002270452671 0.840836002500531 +255.48 13.7763400250084 3.14002376320688 0.840985101854667 +247.79 13.7772398355058 3.1400248211093 0.840222337092132 +245.38 13.7781396463077 3.14002587823399 0.82876728631614 +239.4 13.779039457414 3.14002693458095 0.818641944927036 +243.28 13.7799392688243 3.14002799015016 0.809002100594257 +247.33 13.7808390805386 3.14002904494163 0.830070889785473 +248.77 13.7817388925564 3.14003009895536 0.808049655407262 +244.94 13.7826387048778 3.14003115219135 0.80684265030579 +247.51 13.7835385175023 3.1400322046496 0.801881087274811 +264.97 13.7844383304298 3.14003325633009 0.799218203940045 +247.2 13.78533814366 3.14003430723284 0.808991949623594 +235.02 13.7862379571928 3.14003535735785 0.820990628583381 +245.59 13.7871377710279 3.1400364067051 0.818833286078821 +248.73 13.7880375851651 3.1400374552746 0.815088354740017 +258.2 13.7889373996042 3.14003850306635 0.803716222388687 +271.9 13.7898372143448 3.14003955008035 0.821570841761706 +267.87 13.7907370293869 3.14004059631659 0.801736558862468 +285.02 13.7916368447302 3.14004164177507 0.787446698715337 +277.18 13.7925366603745 3.1400426864558 0.814755113134684 +278.4 13.7934364763195 3.14004373035877 0.794617928492044 +272.49 13.794336292565 3.14004477348398 0.790492504207079 +277.33 13.7952361091108 3.14004581583143 0.77491871528552 +275.37 13.7961359259567 3.14004685740111 0.763524973879534 +276.95 13.7970357431024 3.14004789819303 0.751350489894982 +272.44 13.7979355605478 3.14004893820719 0.751014045118162 +267.71 13.7988353782925 3.14004997744358 0.759160257073547 +265.21 13.7997351963364 3.1400510159022 0.788835857460217 +268.35 13.8006350146793 3.14005205358305 0.751780611592101 +224.36 13.711555592423 3.13904107657968 0.825312392270539 +230.06 13.7124553796308 3.13904219015418 0.81932997242654 +228.47 13.7133551671592 3.13904330295126 0.821964478810233 +231.75 13.714254955008 3.13904441497093 0.814215357146876 +231.71 13.7151547431771 3.13904552621317 0.816365232526764 +228.34 13.7160545316662 3.139046636678 0.81083762917786 +228.22 13.7169543204751 3.13904774636541 0.809558869603359 +235.56 13.7178541096035 3.13904885527539 0.817394507551553 +231.65 13.7187538990512 3.13904996340795 0.812291392589874 +236.49 13.7196536888181 3.13905107076308 0.793422191160809 +231.89 13.7205534789038 3.13905217734079 0.79942824379428 +231.37 13.7214532693082 3.13905328314107 0.805073169135631 +227.71 13.722353060031 3.13905438816392 0.810900223531802 +231.4 13.7232528510721 3.13905549240934 0.81742096919586 +242.84 13.7241526424311 3.13905659587732 0.810611050688562 +242.1 13.7250524341079 3.13905769856788 0.812910887572651 +240.2 13.7259522261022 3.139058800481 0.823691696021642 +240.52 13.7268520184139 3.13905990161668 0.820295343763725 +240.23 13.7277518110426 3.13906100197492 0.814877070306372 +233.4 13.7286516039882 3.13906210155573 0.811135899524299 +239.07 13.7295513972504 3.13906320035909 0.812646709363318 +254.22 13.7304511908291 3.13906429838501 0.794415793595673 +258 13.7313509847239 3.13906539563349 0.806019221041983 +248.34 13.7322507789347 3.13906649210453 0.808046804612607 +246.74 13.7331505734613 3.13906758779812 0.794344778895848 +249.84 13.7340503683034 3.13906868271426 0.805821136076896 +227.08 13.7349501634608 3.13906977685295 0.819504162473699 +232.7 13.7358499589332 3.13907087021419 0.817981011284309 +227.43 13.7367497547205 3.13907196279799 0.824175988907002 +228.74 13.7376495508225 3.13907305460433 0.835215839695995 +242.6 13.7385493472388 3.13907414563321 0.810445871292343 +226.36 13.7394491439693 3.13907523588464 0.811119872206039 +237.49 13.7403489410138 3.13907632535862 0.80398283178857 +236.5 13.741248738372 3.13907741405513 0.810751440615694 +244.69 13.7421485360437 3.13907850197419 0.785729079102859 +244.69 13.7430483340287 3.13907958911579 0.806496869869221 +235.38 13.7439481323268 3.13908067547992 0.81492687270942 +239.78 13.7448479309377 3.13908176106659 0.810254893933191 +243.61 13.7457477298612 3.1390828458758 0.808674554887835 +224.28 13.746647529097 3.13908392990754 0.824474678423776 +232.48 13.7475473286451 3.13908501316181 0.815609903031848 +249.64 13.7484471285051 3.13908609563862 0.811159475263551 +250.14 13.7493469286768 3.13908717733795 0.804065354432008 +247.47 13.75024672916 3.13908825825981 0.820697809433455 +239.35 13.7511465299544 3.1390893384042 0.813090032129801 +243.85 13.7520463310599 3.13909041777112 0.789990219840966 +233.24 13.7529461324763 3.13909149636056 0.804747961104781 +234.35 13.7538459342032 3.13909257417253 0.792743341373991 +233.06 13.7547457362405 3.13909365120701 0.810578921406102 +229.34 13.7556455385879 3.13909472746402 0.811590443849435 +237.65 13.7565453412453 3.13909580294355 0.808261684659642 +246.3 13.7574451442123 3.13909687764559 0.818700542171846 +243.75 13.7583449474889 3.13909795157015 0.829371850856567 +245.18 13.7592447510746 3.13909902471723 0.814893517904687 +230.56 13.7601445549695 3.13910009708682 0.822093661894475 +231.44 13.7610443591731 3.13910116867892 0.813785622873552 +229.48 13.7619441636853 3.13910223949354 0.818840328695418 +232.33 13.7628439685058 3.13910330953066 0.813016537080159 +242.91 13.7637437736345 3.1391043787903 0.816439010938505 +243.89 13.7646435790711 3.13910544727244 0.80220596368693 +251.21 13.7655433848154 3.13910651497709 0.798279467388296 +244.66 13.7664431908671 3.13910758190424 0.798762644254185 +256.65 13.7673429972261 3.1391086480539 0.823407142620726 +245.26 13.7682428038921 3.13910971342605 0.818739680987507 +244.6 13.7691426108648 3.13911077802071 0.825603988841087 +250.64 13.7700424181442 3.13911184183787 0.795498662189812 +247.01 13.7709422257298 3.13911290487753 0.81353499122316 +255.33 13.7718420336216 3.13911396713968 0.80782454326869 +260.46 13.7727418418193 3.13911502862433 0.828602703375072 +241.08 13.7736416503227 3.13911608933147 0.815738861597405 +244.23 13.7745414591315 3.13911714926111 0.823436318310411 +242.07 13.7754412682455 3.13911820841324 0.831818181818182 +251.05 13.7763410776645 3.13911926678786 0.838074276321288 +242.32 13.7772408873883 3.13912032438497 0.837494698897371 +238.71 13.7781406974166 3.13912138120456 0.836521053409782 +236.34 13.7790405077493 3.13912243724665 0.818247936828356 +249.46 13.779940318386 3.13912349251121 0.812880041154548 +247.87 13.7808401293266 3.13912454699826 0.816097622009112 +246.69 13.7817399405709 3.1391256007078 0.803528067695525 +247.01 13.7826397521186 3.13912665363981 0.803837458698047 +247.22 13.7835395639695 3.13912770579431 0.800150045717054 +246.08 13.7844393761234 3.13912875717128 0.81582860725168 +238.94 13.7853391885801 3.13912980777074 0.818254059614035 +246.45 13.7862390013393 3.13913085759266 0.804139075391399 +253.03 13.7871388144008 3.13913190663707 0.806543990580907 +253.67 13.7880386277644 3.13913295490394 0.80686004290826 +249.73 13.7889384414298 3.13913400239329 0.806523691977867 +260.96 13.7898382553969 3.13913504910511 0.812684645971033 +266.9 13.7907380696653 3.1391360950394 0.799204935873222 +287.04 13.791637884235 3.13913714019615 0.803072585239617 +284.19 13.7925376991057 3.13913818457538 0.814969260229792 +285.81 13.793437514277 3.13913922817707 0.800829767162503 +277.58 13.7943373297489 3.13914027100122 0.805600097062228 +267.66 13.7952371455211 3.13914131304784 0.811653518134318 +260.51 13.7961369615934 3.13914235431692 0.810229405918728 +257.66 13.7970367779655 3.13914339480846 0.802281534533542 +268.06 13.7979365946372 3.13914443452246 0.805000728463497 +288.15 13.7988364116083 3.13914547345892 0.777530951342897 +272.55 13.7997362288786 3.13914651161783 0.772314105692698 +263.7 13.8006360464478 3.1391475489992 0.787861493003128 +229.89 13.7115567004534 3.13813660271744 0.818858285206575 +226.58 13.7124564868879 3.13813771597046 0.820934706348308 +232.63 13.713356273643 3.13813882844629 0.819206117989803 +236.09 13.7142560607186 3.13813994014493 0.822503621058066 +231.01 13.7151558481144 3.13814105106637 0.813911479362406 +234.04 13.7160556358302 3.13814216121062 0.822284270805615 +237.18 13.7169554238658 3.13814327057766 0.816943401858816 +233.73 13.717855212221 3.13814437916751 0.818472338443713 +233.13 13.7187550008954 3.13814548698017 0.806181161281904 +229.58 13.719654789889 3.13814659401562 0.813055381727159 +228.59 13.7205545792014 3.13814770027386 0.811415247761428 +232.46 13.7214543688326 3.13814880575491 0.812467166577814 +230.19 13.7223541587821 3.13814991045875 0.817843553091959 +232.33 13.7232539490498 3.13815101438538 0.808783756831146 +233.03 13.7241537396356 3.13815211753481 0.81592642595862 +237.88 13.7250535305391 3.13815321990702 0.807179878286043 +237.23 13.7259533217601 3.13815432150203 0.814435509122429 +241.49 13.7268531132984 3.13815542231982 0.803721744065071 +244.44 13.7277529051539 3.1381565223604 0.813684594049983 +242.55 13.7286526973262 3.13815762162377 0.80863157657776 +235.12 13.7295524898151 3.13815872010992 0.810529746845267 +235.84 13.7304522826205 3.13815981781885 0.823833821879637 +238.81 13.731352075742 3.13816091475056 0.815784265968459 +235.25 13.7322518691795 3.13816201090506 0.808520027022911 +245.77 13.7331516629328 3.13816310628233 0.808556770292555 +238.71 13.7340514570016 3.13816420088238 0.810393087501521 +227.44 13.7349512513856 3.1381652947052 0.81534075627992 +232.03 13.7358510460848 3.1381663877508 0.82329945269742 +236.88 13.7367508410988 3.13816748001918 0.807115646466655 +238.38 13.7376506364274 3.13816857151032 0.811817910001495 +241.39 13.7385504320704 3.13816966222424 0.800727718164345 +231.81 13.7394502280276 3.13817075216092 0.80595795199974 +232.8 13.7403500242988 3.13817184132037 0.803658360244855 +239.89 13.7412498208837 3.13817292970259 0.81127342702897 +235.72 13.7421496177821 3.13817401730758 0.813728537315696 +243.33 13.7430494149938 3.13817510413533 0.804090979661543 +247.27 13.7439492125185 3.13817619018584 0.799095870014046 +246.05 13.744849010356 3.13817727545911 0.80674304369739 +240.41 13.7457488085062 3.13817835995514 0.814335792010516 +231.12 13.7466486069688 3.13817944367393 0.817547111523015 +237.04 13.7475484057435 3.13818052661548 0.808434867004103 +237.15 13.7484482048302 3.13818160877978 0.819551348917901 +245.22 13.7493480042285 3.13818269016684 0.821167688994689 +249.54 13.7502478039384 3.13818377077665 0.80983454089975 +235.29 13.7511476039595 3.13818485060921 0.807583755602007 +248.7 13.7520474042917 3.13818592966452 0.784398330008432 +235.82 13.7529472049347 3.13818700794259 0.811588714258663 +231.36 13.7538470058883 3.1381880854434 0.805250897990659 +234.02 13.7547468071522 3.13818916216695 0.811398828487859 +239.05 13.7556466087263 3.13819023811325 0.817288301806103 +259.95 13.7565464106103 3.1381913132823 0.805137416921142 +256.4 13.7574462128041 3.13819238767409 0.815123274093856 +247.84 13.7583460153073 3.13819346128862 0.813112182996479 +250.8 13.7592458181197 3.13819453412588 0.807261681525589 +244.18 13.7601456212412 3.13819560618589 0.805268105485901 +236.53 13.7610454246714 3.13819667746864 0.812819390803067 +242.39 13.7619452284103 3.13819774797412 0.795362176465462 +235.39 13.7628450324575 3.13819881770233 0.80255224561891 +238.25 13.7637448368128 3.13819988665328 0.80739235222888 +248.62 13.7646446414761 3.13820095482696 0.80508753062078 +252.6 13.765544446447 3.13820202222337 0.80042879771717 +245.46 13.7664442517254 3.13820308884251 0.804440942570556 +244.46 13.767344057311 3.13820415468438 0.825530892998044 +247.5 13.7682438632036 3.13820521974897 0.811637772529276 +255.05 13.769143669403 3.13820628403629 0.790110990872117 +269.52 13.770043475909 3.13820734754634 0.771081051376095 +273.57 13.7709432827213 3.1382084102791 0.792775069572145 +257.96 13.7718430898397 3.13820947223459 0.811763580296886 +254.33 13.7727428972641 3.1382105334128 0.822716452661025 +252.69 13.7736427049941 3.13821159381373 0.798098833788155 +234.37 13.7745425130295 3.13821265343737 0.817020610567544 +228.08 13.7754423213701 3.13821371228373 0.833512954261327 +230.18 13.7763421300158 3.13821477035281 0.823183067121592 +232.78 13.7772419389662 3.1382158276446 0.819775679546598 +224.11 13.7781417482211 3.1382168841591 0.83926467287622 +235.63 13.7790415577804 3.13821793989631 0.811083288641616 +251.61 13.7799413676438 3.13821899485623 0.817419868017912 +257.56 13.7808411778111 3.13822004903886 0.821134119702927 +252.35 13.781740988282 3.1382211024442 0.800978730111135 +243.51 13.7826407990563 3.13822215507225 0.806230702705241 +247.28 13.7835406101338 3.13822320692299 0.803272958010844 +240.96 13.7844404215144 3.13822425799644 0.813126129714163 +241.49 13.7853402331976 3.1382253082926 0.817119832926843 +246.54 13.7862400451834 3.13822635781145 0.815850739416992 +247.11 13.7871398574715 3.138227406553 0.8052735395897 +252.1 13.7880396700617 3.13822845451725 0.806861366288638 +255.3 13.7889394829538 3.1382295017042 0.817689676627846 +252.29 13.7898392961475 3.13823054811384 0.807081570636954 +272.55 13.7907391096426 3.13823159374618 0.807042058145869 +282.07 13.7916389234388 3.13823263860121 0.792961329601214 +288.2 13.7925387375361 3.13823368267893 0.812994713730317 +293.88 13.7934385519341 3.13823472597934 0.795080394489428 +269.38 13.7943383666326 3.13823576850244 0.800195696746109 +266.17 13.7952381816314 3.13823681024823 0.795717322926375 +258.42 13.7961379969302 3.13823785121671 0.83017179557152 +247.86 13.7970378125289 3.13823889140787 0.788592541743221 +249.51 13.7979376284273 3.13823993082171 0.798372801576981 +262.01 13.798837444625 3.13824096945824 0.796031535376868 +261.34 13.7997372611219 3.13824200731744 0.78210931183267 +262.15 13.8006370779177 3.13824304439933 0.801602879207384 +250.26 13.711557808163 3.13723212883914 0.816118140303511 +240.41 13.7124575938244 3.13723324177068 0.817272242824983 +234.52 13.7133573798065 3.13723435392526 0.8307832734725 +231.64 13.714257166109 3.13723546530286 0.822513869028457 +228.43 13.7151569527317 3.1372365759035 0.814964839573236 +235.54 13.7160567396745 3.13723768572717 0.816486110136405 +244.01 13.716956526937 3.13723879477386 0.824000489472933 +239.04 13.7178563145191 3.13723990304358 0.817114666086262 +237.23 13.7187561024205 3.13724101053632 0.789140572951366 +225.96 13.719655890641 3.13724211725209 0.810785552413613 +221.62 13.7205556791804 3.13724322319088 0.830164982801093 +233.7 13.7214554680385 3.13724432835269 0.813461727127969 +229.34 13.7223552572149 3.13724543273752 0.815708515742014 +235.17 13.7232550467096 3.13724653634537 0.806284142110929 +231.18 13.7241548365223 3.13724763917623 0.812335687907018 +238.01 13.7250546266527 3.13724874123011 0.811842125077176 +240.64 13.7259544171007 3.137249842507 0.81054695632753 +236.71 13.7268542078659 3.13725094300691 0.815871304308208 +242.71 13.7277539989483 3.13725204272983 0.809387335542028 +231.2 13.7286537903475 3.13725314167575 0.811364409663151 +242.7 13.7295535820634 3.13725423984469 0.81321621409834 +238.98 13.7304533740956 3.13725533723663 0.817026569360567 +246.86 13.7313531664441 3.13725643385158 0.817129108561602 +245.96 13.7322529591085 3.13725752968953 0.812249043326865 +240.35 13.7331527520887 3.13725862475049 0.811833361570754 +233.97 13.7340525453844 3.13725971903444 0.810949529512404 +225.52 13.7349523389954 3.1372608125414 0.809122618509791 +231.96 13.7358521329215 3.13726190527136 0.79703085986987 +228.61 13.7367519271624 3.13726299722431 0.815331352376167 +230.82 13.7376517217179 3.13726408840026 0.816887776322285 +232.43 13.7385515165879 3.13726517879921 0.821068886294301 +237.68 13.739451311772 3.13726626842115 0.805474181626609 +240.62 13.7403511072701 3.13726735726608 0.805693603938433 +238.39 13.7412509030819 3.13726844533401 0.81821831347156 +240.78 13.7421506992072 3.13726953262492 0.820859801297692 +243.12 13.7430504956457 3.13727061913882 0.810379924970745 +235.13 13.7439502923974 3.13727170487571 0.81771672831034 +242.64 13.7448500894618 3.13727278983558 0.809321528647231 +235.9 13.7457498868389 3.13727387401844 0.809659529767974 +232.54 13.7466496845284 3.13727495742428 0.830757693628533 +238.08 13.74754948253 3.1372760400531 0.822403409617345 +251.01 13.7484492808435 3.1372771219049 0.814164269414163 +247.67 13.7493490794688 3.13727820297968 0.806308130929939 +236.32 13.7502488784056 3.13727928327744 0.806505531059979 +235.98 13.7511486776536 3.13728036279818 0.809006038896198 +233.96 13.7520484772127 3.13728144154189 0.801893705251696 +240.61 13.7529482770825 3.13728251950857 0.813561528191511 +240.74 13.753848077263 3.13728359669823 0.815696360716958 +245.33 13.7547478777538 3.13728467311085 0.814400702684023 +253.21 13.7556476785548 3.13728574874645 0.811458882874549 +251.97 13.7565474796657 3.13728682360501 0.795452862904011 +247.42 13.7574472810863 3.13728789768654 0.821586319377848 +247.28 13.7583470828164 3.13728897099104 0.813362323113207 +247.46 13.7592468848557 3.1372900435185 0.802499685131541 +236.69 13.7601466872041 3.13729111526893 0.814648088603072 +234.27 13.7610464898612 3.13729218624231 0.807666602073059 +236.49 13.761946292827 3.13729325643866 0.813514989289274 +239.67 13.762846096101 3.13729432585796 0.80271470569838 +245.22 13.7637458996832 3.13729539450023 0.807375627226772 +242.72 13.7646457035734 3.13729646236545 0.822615045367458 +248.77 13.7655455077711 3.13729752945362 0.796955627387599 +245.41 13.7664453122764 3.13729859576475 0.794522898891831 +241.96 13.7673451170889 3.13729966129883 0.806059419067133 +256.86 13.7682449222084 3.13730072605586 0.794332052332537 +262.66 13.7691447276347 3.13730179003584 0.811308541282325 +273.06 13.7700445333675 3.13730285323877 0.79153804520259 +259.12 13.7709443394067 3.13730391566465 0.80998723150489 +252.74 13.771844145752 3.13730497731347 0.804530860769691 +249.77 13.7727439524031 3.13730603818524 0.820913755191791 +245.78 13.77364375936 3.13730709827995 0.806893140478941 +231.27 13.7745435666223 3.13730815759761 0.806600678664729 +221.77 13.7754433741898 3.1373092161382 0.824567672969655 +225.54 13.7763431820623 3.13731027390173 0.817039842738649 +233.77 13.7772429902395 3.1373113308882 0.820924222379473 +234.15 13.7781427987214 3.13731238709761 0.81979418745796 +238.41 13.7790426075075 3.13731344252995 0.82646077681066 +246.63 13.7799424165977 3.13731449718523 0.815484736106429 +255.24 13.7808422259918 3.13731555106344 0.812663256619397 +253.09 13.7817420356896 3.13731660416458 0.806262449920544 +243.76 13.7826418456908 3.13731765648865 0.808094020264335 +245.95 13.7835416559951 3.13731870803565 0.801941324026611 +244.91 13.7844414666025 3.13731975880558 0.811385849520531 +251.83 13.7853412775126 3.13732080879844 0.807534816876347 +248.55 13.7862410887253 3.13732185801422 0.807324921703023 +241.05 13.7871409002402 3.13732290645292 0.815202826166403 +247.39 13.7880407120572 3.13732395411455 0.825627267880789 +247.72 13.7889405241761 3.13732500099909 0.815657999726837 +257.78 13.7898403365967 3.13732604710656 0.804269123562011 +265.95 13.7907401493186 3.13732709243695 0.793395446439495 +259.01 13.7916399623417 3.13732813699025 0.796152173587056 +262.12 13.7925397756658 3.13732918076647 0.820368478296694 +265.29 13.7934395892906 3.1373302237656 0.808970707679866 +252.95 13.7943394032159 3.13733126598765 0.811640606307967 +255.59 13.7952392174416 3.13733230743261 0.800883260100381 +252.48 13.7961390319672 3.13733334810048 0.816111609577594 +244.5 13.7970388467928 3.13733438799126 0.801221565637311 +245.6 13.7979386619179 3.13733542710494 0.808786235562069 +266.91 13.7988384773425 3.13733646544154 0.797219656968834 +262.37 13.7997382930662 3.13733750300104 0.795978424420776 +260.46 13.8006381090888 3.13733853978344 0.81392920677673 +247.36 13.7115589155516 3.13632765494478 0.803467749496931 +244.2 13.7124587004402 3.13632876755484 0.807612724919756 +237.51 13.7133584856494 3.13632987938816 0.818840112593738 +232.06 13.7142582711791 3.13633099044474 0.836495650387013 +236.08 13.7151580570291 3.13633210072457 0.810475887493684 +239.91 13.716057843199 3.13633321022766 0.82317673761295 +238.93 13.7169576296887 3.136334318954 0.836308792752783 +233.18 13.7178574164979 3.13633542690358 0.815543986279125 +229.87 13.7187572036265 3.13633653407642 0.795492438523732 +226.09 13.7196569910742 3.13633764047251 0.816695936699193 +226.17 13.7205567788407 3.13633874609184 0.821925925925926 +233.44 13.7214565669259 3.13633985093441 0.824343315802437 +236.13 13.7223563553296 3.13634095500023 0.820511715439095 +237.04 13.7232561440514 3.1363420582893 0.816798824191178 +230.71 13.7241559330912 3.1363431608016 0.814364597915694 +233.02 13.7250557224488 3.13634426253714 0.808266792292984 +235.44 13.7259555121239 3.13634536349593 0.818509539291154 +240.38 13.7268553021163 3.13634646367795 0.808049512179436 +240.35 13.7277550924258 3.1363475630832 0.813868071529272 +239.48 13.7286548830522 3.13634866171169 0.813759808253154 +239.59 13.7295546739952 3.13634975956341 0.807869187531937 +230.28 13.7304544652546 3.13635085663836 0.813223317192529 +241.13 13.7313542568303 3.13635195293655 0.809511649156688 +233.26 13.7322540487218 3.13635304845796 0.812304837850108 +226.5 13.7331538409292 3.1363541432026 0.810209471437358 +227.81 13.734053633452 3.13635523717047 0.812428380443086 +231.38 13.7349534262901 3.13635633036156 0.817116377332886 +231.82 13.7358532194433 3.13635742277587 0.802467020729827 +235.34 13.7367530129114 3.13635851441341 0.800359077812082 +236.91 13.7376528066941 3.13635960527416 0.801826973076595 +234.85 13.7385526007911 3.13636069535814 0.80739996230919 +239.53 13.7394523952024 3.13636178466534 0.801519114443734 +231.49 13.7403521899276 3.13636287319575 0.804887455156816 +238.95 13.7412519849665 3.13636396094937 0.80378322051021 +234.63 13.7421517803189 3.13636504792622 0.800528912957552 +237.57 13.7430515759847 3.13636613412627 0.816817497939773 +248.33 13.7439513719634 3.13636721954953 0.802610114192496 +244.63 13.744851168255 3.13636830419601 0.810977214124086 +246.52 13.7457509648592 3.13636938806569 0.807052135514073 +246.52 13.7466507617758 3.13637047115858 0.82483283713212 +250.77 13.7475505590045 3.13637155347468 0.808630829363094 +247.92 13.7484503565452 3.13637263501398 0.79940182788054 +241.39 13.7493501543976 3.13637371577649 0.804652091444544 +238.41 13.7502499525615 3.1363747957622 0.802966207136814 +234.52 13.7511497510366 3.1363758749711 0.801865530458815 +238.16 13.7520495498228 3.13637695340321 0.800204172106511 +240.72 13.7529493489198 3.13637803105852 0.810564896066951 +244.12 13.7538491483274 3.13637910793702 0.813531388608239 +246.2 13.7547489480453 3.13638018403872 0.817654729521299 +252.97 13.7556487480734 3.13638125936361 0.801001659329752 +252.12 13.7565485484114 3.13638233391169 0.797862988021424 +261.59 13.7574483490591 3.13638340768297 0.811029373035799 +260.27 13.7583481500163 3.13638448067743 0.792680876501466 +250.91 13.7592479512827 3.13638555289509 0.81459107971717 +255.12 13.7601477528582 3.13638662433593 0.795091409392377 +243.49 13.7610475547424 3.13638769499996 0.801883811094753 +234.44 13.7619473569353 3.13638876488717 0.809833236822367 +235.34 13.7628471594364 3.13638983399757 0.810779231092103 +241.21 13.7637469622457 3.13639090233114 0.817867885803642 +239.97 13.764646765363 3.1363919698879 0.8235028643388 +246.24 13.7655465687878 3.13639303666784 0.810743565689114 +246.91 13.7664463725202 3.13639410267096 0.814693046687365 +248.31 13.7673461765598 3.13639516789725 0.811226875666374 +267.86 13.7682459809064 3.13639623234672 0.792498615740792 +267.21 13.7691457855597 3.13639729601937 0.809888258503009 +267.72 13.7700455905197 3.13639835891518 0.815401465419835 +254.25 13.7709453957859 3.13639942103417 0.810925454612519 +251.13 13.7718452013583 3.13640048237633 0.813656251971543 +240.91 13.7727450072366 3.13640154294166 0.813600058451871 +245.15 13.7736448134205 3.13640260273015 0.807888819201175 +231.65 13.7745446199099 3.13640366174181 0.814202465387322 +227.49 13.7754444267044 3.13640471997664 0.82384378368873 +238.07 13.776344233804 3.13640577743463 0.817516834345483 +243.78 13.7772440412084 3.13640683411578 0.820450141600835 +244.78 13.7781438489173 3.1364078900201 0.811334281428377 +235.48 13.7790436569305 3.13640894514757 0.832978458251736 +243.09 13.7799434652478 3.13640999949821 0.816998889474688 +250.4 13.780843273869 3.136411053072 0.811458701073897 +248.71 13.7817430827938 3.13641210586894 0.817659050555681 +244.94 13.782642892022 3.13641315788904 0.8013608189769 +240.84 13.7835427015535 3.1364142091323 0.812955789620915 +248.78 13.7844425113879 3.1364152595987 0.79363715899149 +255.64 13.7853423215251 3.13641630928826 0.786620948864198 +259.22 13.7862421319648 3.13641735820097 0.80305692587065 +244.38 13.7871419427068 3.13641840633682 0.802071221071544 +246.66 13.7880417537509 3.13641945369582 0.822189364735703 +240.25 13.7889415650969 3.13642050027797 0.820034043052723 +256.47 13.7898413767444 3.13642154608326 0.79910969234599 +251.28 13.7907411886934 3.13642259111169 0.804628474614139 +263.09 13.7916410009436 3.13642363536327 0.790412214669623 +259.25 13.7925408134947 3.13642467883799 0.793313712970974 +250.81 13.7934406263466 3.13642572153584 0.805248316013569 +251.98 13.794340439499 3.13642676345684 0.812308138979078 +245.76 13.7952402529517 3.13642780460097 0.800238140964087 +246.12 13.7961400667044 3.13642884496823 0.80825855513308 +244.62 13.797039880757 3.13642988455863 0.811238348460062 +256.29 13.7979396951092 3.13643092337217 0.795436741088915 +252.9 13.7988395097608 3.13643196140883 0.81175251127419 +260.96 13.7997393247115 3.13643299866862 0.807503860732837 +269.68 13.8006391399612 3.13643403515155 0.828164564741746 +237.47 13.7115600226193 3.13542318103436 0.817792799326931 +238.37 13.7124598067353 3.13542429332295 0.814697944623493 +237.88 13.713359591172 3.13542540483502 0.823897438762115 +234.26 13.7142593759291 3.13542651557056 0.813457665050354 +234.01 13.7151591610064 3.13542762552959 0.827977471364787 +240.22 13.7160589464037 3.1354287347121 0.817661087534494 +239.32 13.7169587321208 3.13542984311808 0.831073787686438 +227.79 13.7178585181574 3.13543095074754 0.816669295974081 +227.44 13.7187583045134 3.13543205760047 0.819413479677585 +237.93 13.7196580911884 3.13543316367687 0.814585801067148 +237.39 13.7205578781824 3.13543426897674 0.798285103557722 +236.42 13.721457665495 3.13543537350009 0.815471041035477 +240.34 13.722357453126 3.1354364772469 0.809484329147894 +237.49 13.7232572410752 3.13543758021718 0.81623934712996 +238.52 13.7241570293424 3.13543868241092 0.814640322187499 +232.7 13.7250568179274 3.13543978382813 0.820308417062309 +232.4 13.7259566068299 3.1354408844688 0.810863615540929 +230.39 13.7268563960497 3.13544198433293 0.809548147287722 +236.82 13.7277561855865 3.13544308342053 0.826871300612854 +242.5 13.7286559754403 3.13544418173158 0.820002793986481 +237.67 13.7295557656107 3.13544527926609 0.809577099548891 +239.45 13.7304555560975 3.13544637602405 0.803569094258155 +233.44 13.7313553469004 3.13544747200547 0.817294098560756 +230.29 13.7322551380194 3.13544856721034 0.814527444325854 +230.49 13.7331549294541 3.13544966163867 0.809955674907443 +225.32 13.7340547212043 3.13545075529044 0.819185343089244 +229.07 13.7349545132698 3.13545184816567 0.812665520240199 +231.12 13.7358543056504 3.13545294026434 0.810306474560018 +234.51 13.7367540983458 3.13545403158646 0.810386721489996 +237.99 13.7376538913558 3.13545512213202 0.81756099010931 +243.61 13.7385536846802 3.13545621190103 0.81465116022384 +235.08 13.7394534783188 3.13545730089348 0.815171585671238 +233.58 13.7403532722714 3.13545838910937 0.812889076139814 +237.01 13.7412530665377 3.1354594765487 0.81401102677276 +241.17 13.7421528611175 3.13546056321147 0.808717592980798 +232.35 13.7430526560105 3.13546164909768 0.816868799926404 +244.75 13.7439524512166 3.13546273420733 0.813807454466577 +244.99 13.7448522467356 3.1354638185404 0.81535766858591 +259.21 13.7457520425671 3.13546490209691 0.806792252776972 +262.72 13.7466518387111 3.13546598487686 0.792133906247661 +237.02 13.7475516351671 3.13546706688023 0.802715638711881 +235.95 13.7484514319352 3.13546814810703 0.804125857852643 +245.53 13.7493512290149 3.13546922855726 0.794143125270706 +237.75 13.7502510264061 3.13547030823092 0.815270209727014 +246.4 13.7511508241086 3.135471387128 0.799694303171507 +232.58 13.7520506221221 3.1354724652485 0.803981935990575 +242.72 13.7529504204464 3.13547354259243 0.807674300874311 +247.22 13.7538502190814 3.13547461915978 0.813281648915131 +243.52 13.7547500180266 3.13547569495055 0.812098421816244 +248.45 13.7556498172821 3.13547676996474 0.795738641963142 +264.05 13.7565496168474 3.13547784420234 0.784515434620165 +268.06 13.7574494167224 3.13547891766336 0.801914053559167 +254.23 13.758349216907 3.1354799903478 0.796128974110543 +250.47 13.7592490174007 3.13548106225564 0.802258839609301 +248.78 13.7601488182035 3.1354821333869 0.805945011432714 +238.99 13.7610486193151 3.13548320374157 0.804237995179532 +233.39 13.7619484207352 3.13548427331965 0.823700916647304 +234.91 13.7628482224637 3.13548534212114 0.823996594145453 +241.68 13.7637480245004 3.13548641014604 0.815796324256781 +241.21 13.7646478268449 3.13548747739433 0.810721366420088 +253.02 13.7655476294971 3.13548854386604 0.809993986681613 +247.72 13.7664474324568 3.13548960956114 0.81434061342014 +255.19 13.7673472357237 3.13549067447965 0.820815086925541 +268.61 13.7682470392976 3.13549173862156 0.798770889487871 +264.71 13.7691468431782 3.13549280198687 0.807754986095745 +258.97 13.7700466473655 3.13549386457557 0.796331919469502 +242.7 13.7709464518591 3.13549492638767 0.81324981379982 +243.65 13.7718462566587 3.13549598742316 0.801717803045268 +243.89 13.7727460617643 3.13549704768205 0.79834701331663 +228.15 13.7736458671755 3.13549810716433 0.816949828110209 +231.63 13.7745456728922 3.13549916587 0.827808218676681 +234.67 13.7754454789141 3.13550022379906 0.822385687077278 +235.44 13.776345285241 3.13550128095151 0.815976588487289 +248.1 13.7772450918726 3.13550233732735 0.805755423379723 +248.01 13.7781448988088 3.13550339292657 0.810056896107938 +250.37 13.7790447060493 3.13550444774917 0.812115201077905 +240.57 13.7799445135939 3.13550550179516 0.803519296782266 +241.9 13.7808443214424 3.13550655506453 0.809013132715035 +237.9 13.7817441295945 3.13550760755728 0.820068611911087 +248.55 13.7826439380501 3.13550865927341 0.820728311291927 +244.63 13.7835437468088 3.13550971021292 0.812893586822545 +250.24 13.7844435558706 3.13551076037581 0.810383275781058 +246.3 13.785343365235 3.13551180976207 0.806937974993871 +252.6 13.786243174902 3.1355128583717 0.811185279522199 +247.91 13.7871429848713 3.13551390620471 0.818482179331895 +247.68 13.7880427951427 3.13551495326108 0.818427670481171 +243.48 13.7889426057159 3.13551599954083 0.826710200389885 +250.1 13.7898424165908 3.13551704504395 0.799601528112918 +250.08 13.7907422277671 3.13551808977043 0.814511764833214 +239.88 13.7916420392445 3.13551913372028 0.820262798671885 +238.27 13.7925418510229 3.1355201768935 0.828213166144201 +260.31 13.7934416631021 3.13552121929008 0.786496509021354 +275.21 13.7943414754818 3.13552226091002 0.778814869118653 +259.04 13.7952412881617 3.13552330175332 0.801867446062438 +249.28 13.7961411011417 3.13552434181998 0.799543097796937 +250.27 13.7970409144216 3.13552538111 0.799476102480219 +245.62 13.7979407280011 3.13552641962338 0.807147258163894 +258.55 13.7988405418799 3.13552745736012 0.807545780282967 +262.13 13.7997403560579 3.13552849432021 0.811296371636336 +257.86 13.8006401705349 3.13552953050365 0.814476110937119 +228.7 13.7115611293662 3.13451870710789 0.825419208709312 +238.65 13.7124609127098 3.134519819075 0.807277593064158 +233.9 13.713360696374 3.13452093026582 0.820848511609081 +240.05 13.7142604803588 3.13452204068034 0.815557974638854 +230.34 13.7151602646637 3.13452315031856 0.811712682838551 +236.47 13.7160600492886 3.13452425918049 0.823319659655887 +241.16 13.7169598342333 3.13452536726612 0.81775782407811 +241.3 13.7178596194976 3.13452647457544 0.814240828493375 +237.04 13.7187594050812 3.13452758110847 0.822610815399844 +234.41 13.7196591909838 3.13452868686519 0.812262251062878 +237.44 13.7205589772054 3.13452979184561 0.807015164869935 +229.96 13.7214587637456 3.13453089604972 0.81468899723102 +233.38 13.7223585506042 3.13453199947752 0.8211276875025 +232.72 13.723258337781 3.13453310212902 0.821469103724278 +240.8 13.7241581252758 3.1345342040042 0.821074518650383 +241.41 13.7250579130884 3.13453530510307 0.81639967553699 +236.1 13.7259577012185 3.13453640542564 0.8176900089797 +238.19 13.7268574896659 3.13453750497188 0.821522155807127 +235.16 13.7277572784304 3.13453860374181 0.829514801553628 +235.41 13.7286570675117 3.13453970173543 0.819454958364875 +248.95 13.7295568569097 3.13454079895272 0.798297319996946 +238.24 13.7304566466241 3.1345418953937 0.804794978487096 +230.74 13.7313564366547 3.13454299105836 0.818650082755434 +238.95 13.7322562270012 3.13454408594669 0.799427003962207 +228.91 13.7331560176635 3.1345451800587 0.803962409991457 +232.39 13.7340558086413 3.13454627339438 0.804295642181978 +228.89 13.7349555999344 3.13454736595374 0.814315232280083 +228.84 13.7358553915425 3.13454845773677 0.812404692756266 +246.58 13.7367551834655 3.13454954874347 0.797938112639147 +230.09 13.7376549757031 3.13455063897385 0.813782773248568 +239.05 13.7385547682552 3.13455172842789 0.815866768597127 +245.25 13.7394545611213 3.13455281710559 0.808601162685623 +232.82 13.7403543543015 3.13455390500696 0.812084889590398 +237.53 13.7412541477953 3.134554992132 0.810699812331711 +236.2 13.7421539416027 3.1345560784807 0.816120718074744 +230.11 13.7430537357233 3.13455716405306 0.820390961262554 +241.64 13.743953530157 3.13455824884908 0.810153109719089 +248.66 13.7448533249035 3.13455933286876 0.809466924381096 +256.99 13.7457531199627 3.1345604161121 0.809488400805314 +248.07 13.7466529153342 3.1345614985791 0.79713414584304 +239.72 13.7475527110178 3.13456258026974 0.797875840220945 +238.24 13.7484525070134 3.13456366118405 0.81775766200724 +251.06 13.7493523033207 3.134564741322 0.813365006481891 +251.42 13.7502520999395 3.13456582068361 0.815558312026935 +249.15 13.7511518968695 3.13456689926886 0.808645030695695 +252.77 13.7520516941106 3.13456797707777 0.79539678481736 +246.47 13.7529514916625 3.13456905411032 0.805771984025318 +250.9 13.753851289525 3.13457013036651 0.812352830706557 +244.13 13.7547510876978 3.13457120584636 0.810028830313015 +242.95 13.7556508861808 3.13457228054984 0.804953956684881 +249.55 13.7565506849737 3.13457335447696 0.803957572177342 +259.98 13.7574504840763 3.13457442762773 0.803924872174283 +259.04 13.7583502834884 3.13457550000213 0.80562847689343 +238.16 13.7592500832097 3.13457657160018 0.817003248551625 +235.58 13.76014988324 3.13457764242185 0.815781512996129 +243.68 13.7610496835791 3.13457871246717 0.81129976647708 +238.81 13.7619494842268 3.13457978173611 0.820617251108122 +242.76 13.7628492851829 3.13458085022869 0.816346399446211 +251.68 13.7637490864471 3.1345819179449 0.804546130300039 +255.13 13.7646488880191 3.13458298488475 0.813868494983759 +256.74 13.7655486898989 3.13458405104821 0.813363395731658 +255.8 13.7664484920861 3.13458511643531 0.820561168491262 +256.29 13.7673482945805 3.13458618104603 0.814982233073074 +254.96 13.768248097382 3.13458724488038 0.799918669186918 +261.2 13.7691479004902 3.13458830793835 0.803835250708704 +254.08 13.770047703905 3.13458937021994 0.81126651598125 +246.05 13.7709475076261 3.13459043172515 0.806443917754248 +246.64 13.7718473116533 3.13459149245398 0.809267266118232 +241.7 13.7727471159864 3.13459255240643 0.809162509423974 +238.3 13.7736469206252 3.1345936115825 0.821992483324492 +232.67 13.7745467255694 3.13459466998217 0.823058621601223 +236.37 13.7754465308188 3.13459572760547 0.820011477137617 +243.94 13.7763463363732 3.13459678445238 0.824194460146976 +245.77 13.7772461422324 3.1345978405229 0.817241570643831 +255.49 13.7781459483961 3.13459889581702 0.817268989396235 +262.55 13.7790457548641 3.13459995033476 0.805931800629715 +240.98 13.7799455616363 3.13460100407611 0.816920500757515 +241.39 13.7808453687122 3.13460205704106 0.820674793015092 +238.63 13.7817451760919 3.13460310922962 0.828600359000322 +251.5 13.782644983775 3.13460416064178 0.822452519110121 +242.65 13.7835447917612 3.13460521127754 0.812045769658556 +249.52 13.7844446000505 3.1346062611369 0.806942433855915 +247.38 13.7853444086424 3.13460731021986 0.806843892478107 +255.54 13.7862442175369 3.13460835852643 0.804151439403724 +248.55 13.7871440267338 3.13460940605659 0.801146411366547 +239.88 13.7880438362326 3.13461045281034 0.821420129363141 +237.71 13.7889436460334 3.13461149878769 0.824383837374465 +242.73 13.7898434561358 3.13461254398863 0.808878950528825 +236.71 13.7907432665396 3.13461358841317 0.814515406664278 +235.77 13.7916430772445 3.13461463206129 0.823648896624649 +237.22 13.7925428882504 3.134615674933 0.821256939884186 +255.6 13.7934426995571 3.13461671702831 0.81120474597992 +267.14 13.7943425111643 3.1346177583472 0.7932454910756 +249.81 13.7952423230717 3.13461879888967 0.811401530555658 +247.04 13.7961421352792 3.13461983865573 0.797026986184791 +252.21 13.7970419477866 3.13462087764537 0.806993079803513 +247.93 13.7979417605935 3.1346219158586 0.798599564051619 +257.26 13.7988415736999 3.1346229532954 0.805911812274778 +247.23 13.7997413871054 3.13462398995578 0.825928226626457 +248.91 13.8006412008099 3.13462502583974 0.821947449768161 +228.65 13.7115622357921 3.13361423316538 0.814793962718165 +235.12 13.7124620183636 3.13361534481101 0.806930577496245 +237.76 13.7133618012557 3.13361645568057 0.813021628427844 +235.13 13.7142615844683 3.13361756577407 0.815648614021523 +231.86 13.715161368001 3.13361867509149 0.819677034597106 +236.17 13.7160611518538 3.13361978363284 0.819558019501925 +248.37 13.7169609360263 3.13362089139811 0.808304555946501 +237.67 13.7178607205184 3.13362199838731 0.814938569886393 +235.84 13.7187605053298 3.13362310460043 0.821802797620348 +233.92 13.7196602904604 3.13362421003747 0.820423929529374 +236.44 13.7205600759097 3.13362531469843 0.817508624667648 +238.1 13.7214598616778 3.13362641858331 0.819752143430259 +235.91 13.7223596477642 3.1336275216921 0.820269003522327 +238.99 13.7232594341689 3.13362862402481 0.823537749555283 +238.23 13.7241592208915 3.13362972558144 0.813625643831481 +235.95 13.7250590079319 3.13363082636198 0.81559828656615 +232.84 13.7259587952898 3.13363192636643 0.823700314342578 +238.74 13.726858582965 3.13363302559479 0.812588558520974 +236.09 13.7277583709573 3.13363412404706 0.825621682942602 +243.23 13.7286581592665 3.13363522172324 0.812937344318835 +250.76 13.7295579478923 3.13363631862332 0.809391933009507 +245.49 13.7304577368345 3.13363741474731 0.817252815335836 +231.38 13.7313575260929 3.13363851009521 0.807752530695743 +229.5 13.7322573156673 3.133639604667 0.81141682794948 +231.72 13.7331571055574 3.13364069846269 0.821641328520909 +222.86 13.734056895763 3.13364179148229 0.825686249972395 +228.5 13.7349566862839 3.13364288372578 0.827010883611406 +227.57 13.7358564771198 3.13364397519317 0.818971623895746 +229.49 13.7367562682707 3.13364506588446 0.811881303290798 +238.61 13.7376560597361 3.13364615579964 0.813424404272802 +243.7 13.7385558515159 3.13364724493871 0.815801555192104 +239.47 13.7394556436099 3.13364833330167 0.816900370091859 +240.97 13.7403554360178 3.13364942088853 0.804890028087732 +243.36 13.7412552287395 3.13365050769927 0.81368745427539 +246.39 13.7421550217747 3.1336515937339 0.80685093988349 +242.18 13.7430548151231 3.13365267899241 0.811822338825029 +246.31 13.7439546087846 3.13365376347481 0.808262496517765 +242.3 13.7448544027589 3.1336548471811 0.824042991290195 +251.7 13.7457541970458 3.13365593011126 0.806028853226848 +242.52 13.7466539916451 3.13365701226531 0.799765175245083 +237.19 13.7475537865566 3.13365809364324 0.805130768345849 +243.9 13.7484535817799 3.13365917424504 0.812113730091692 +250.44 13.749353377315 3.13366025407072 0.811619891320568 +249.42 13.7502531731616 3.13366133312028 0.822849780256632 +250.27 13.7511529693194 3.13366241139371 0.819813382072036 +246.46 13.7520527657883 3.13366348889101 0.819080124899432 +246.81 13.752952562568 3.13366456561218 0.810886090640051 +244.49 13.7538523596582 3.13366564155723 0.810847328215704 +247.02 13.7547521570589 3.13366671672614 0.808363155204042 +238.36 13.7556519547696 3.13366779111892 0.801889741062198 +236.82 13.7565517527903 3.13366886473557 0.806572623187839 +250.16 13.7574515511207 3.13366993757608 0.805554505951256 +251.01 13.7583513497605 3.13367100964045 0.808353987994707 +243.59 13.7592511487096 3.13367208092869 0.813902642433714 +238.38 13.7601509479677 3.13367315144079 0.813804446023056 +241.61 13.7610507475346 3.13367422117674 0.809329432667565 +236.21 13.7619505474101 3.13367529013656 0.814327042500985 +247.63 13.7628503475939 3.13367635832023 0.794422004539577 +245.73 13.7637501480859 3.13367742572776 0.802808154555986 +256.59 13.7646499488857 3.13367849235914 0.814940092626291 +265.46 13.7655497499932 3.13367955821437 0.808936633971664 +274.5 13.7664495514082 3.13368062329346 0.824882960183163 +282.46 13.7673493531304 3.1336816875964 0.809901076230955 +265.86 13.7682491551596 3.13368275112318 0.825079751373039 +259 13.7691489574956 3.13368381387381 0.800261779075755 +256.53 13.7700487601381 3.13368487584829 0.796126732673268 +247.03 13.770948563087 3.13368593704662 0.807298750203627 +247.46 13.771848366342 3.13368699746879 0.802863667835953 +253.92 13.7727481699028 3.1336880571148 0.802935235886369 +248.01 13.7736479737694 3.13368911598465 0.812118849061389 +243.85 13.7745477779413 3.13369017407834 0.819012270979834 +245.51 13.7754475824185 3.13369123139587 0.811960914185353 +247.8 13.7763473872006 3.13369228793723 0.80647847829492 +258.18 13.7772471922876 3.13369334370244 0.809977144508199 +261.95 13.778146997679 3.13369439869147 0.806283618400006 +255.46 13.7790468033748 3.13369545290434 0.798848871488512 +242.42 13.7799466093747 3.13369650634105 0.817420831180335 +238.14 13.7808464156784 3.13369755900158 0.821985514991799 +236.9 13.7817462222858 3.13369861088594 0.815887582449097 +242.39 13.7826460291966 3.13369966199413 0.813023142248911 +250.6 13.7835458364106 3.13370071232615 0.812323093992245 +252.55 13.7844456439276 3.13370176188199 0.807301017354877 +252.28 13.7853454517473 3.13370281066166 0.80791676091382 +257.03 13.7862452598696 3.13370385866515 0.812396733575372 +240.28 13.7871450682941 3.13370490589246 0.8131261342486 +222.43 13.7880448770207 3.13370595234359 0.824195096249741 +228.69 13.7889446860492 3.13370699801854 0.823177123953032 +235.26 13.7898444953793 3.13370804291731 0.813724556464363 +243.16 13.7907443050108 3.1337090870399 0.818649480721493 +236.29 13.7916441149435 3.1337101303863 0.821409664421635 +246.84 13.7925439251772 3.13371117295651 0.821009421120888 +250.02 13.7934437357116 3.13371221475054 0.811303813445496 +262.56 13.7943435465465 3.13371325576837 0.792890134334389 +250.39 13.7952433576816 3.13371429601002 0.813012330749922 +242.47 13.7961431691169 3.13371533547548 0.804227955574354 +241.98 13.7970429808519 3.13371637416474 0.802098360655738 +241.37 13.7979427928866 3.13371741207781 0.82203133075511 +244.42 13.7988426052207 3.13371844921469 0.80933292996521 +250.59 13.7997424178539 3.13371948557537 0.8034404536862 +250.83 13.8006422307861 3.13372052115985 0.805238153432526 +226.85 13.7115633418972 3.13270975920682 0.815129992221184 +228.99 13.7124631236967 3.13271087053098 0.822832269167176 +233.92 13.7133629058169 3.13271198107929 0.822299432626735 +232.63 13.7142626882575 3.13271309085175 0.817852559965376 +239.22 13.7151624710184 3.13271419984837 0.820459395004393 +236.39 13.7160622540992 3.13271530806914 0.817418061379609 +241.41 13.7169620374998 3.13271641551406 0.820661072990116 +240.78 13.71786182122 3.13271752218313 0.814330431799665 +237.79 13.7187616052594 3.13271862807635 0.830059014561581 +236.48 13.719661389618 3.13271973319371 0.810606002264134 +237.07 13.7205611742954 3.13272083753521 0.817361049787181 +244.9 13.7214609592915 3.13272194110086 0.813414359666892 +233.75 13.722360744606 3.13272304389065 0.827354893124287 +244.85 13.7232605302387 3.13272414590458 0.824201528834605 +238.91 13.7241603161894 3.13272524714264 0.81838838597491 +233.91 13.7250601024579 3.13272634760485 0.820602935997062 +241.71 13.7259598890438 3.13272744729119 0.812513920084559 +238.46 13.7268596759471 3.13272854620167 0.820215219902557 +243.98 13.7277594631675 3.13272964433628 0.819169709420074 +248.33 13.7286592507047 3.13273074169502 0.808676072460003 +242.14 13.7295590385585 3.13273183827789 0.812084105559644 +239.86 13.7304588267288 3.13273293408489 0.818029018277746 +233.76 13.7313586152152 3.13273402911602 0.815555478268934 +225.24 13.7322584040176 3.13273512337128 0.818645095435812 +231.75 13.7331581931357 3.13273621685066 0.811935055144059 +230.83 13.7340579825694 3.13273730955417 0.815206952013978 +224.83 13.7349577723183 3.1327384014818 0.81526365201064 +233.44 13.7358575623823 3.13273949263354 0.824324616771866 +244.84 13.7367573527612 3.13274058300941 0.800957858090823 +244.34 13.7376571434546 3.1327416726094 0.812060282968401 +237.02 13.7385569344625 3.13274276143351 0.802012698804093 +242.27 13.7394567257845 3.13274384948173 0.80826539005318 +245.16 13.7403565174205 3.13274493675406 0.810787032396735 +247.25 13.7412563093702 3.13274602325051 0.825105802379555 +243.4 13.7421561016333 3.13274710897107 0.825436897277565 +247.59 13.7430558942098 3.13274819391574 0.814041378321202 +247.02 13.7439556870993 3.13274927808452 0.803224541505791 +245.38 13.7448554803017 3.13275036147741 0.811236593083507 +245.16 13.7457552738166 3.1327514440944 0.804056060924078 +229.75 13.7466550676439 3.1327525259355 0.819371727748691 +238.61 13.7475548617834 3.13275360700071 0.801791425175528 +242.34 13.7484546562348 3.13275468729001 0.808307947095333 +238.94 13.7493544509979 3.13275576680342 0.80367082055978 +252.1 13.7502542460725 3.13275684554093 0.803023433841946 +251.53 13.7511540414583 3.13275792350253 0.803471874976677 +247.88 13.7520538371552 3.13275900068823 0.812477741920088 +242.61 13.7529536331629 3.13276007709803 0.820935254140429 +248.51 13.7538534294811 3.13276115273192 0.810115038510982 +238.52 13.7547532261098 3.13276222758991 0.819317349269512 +235.02 13.7556530230485 3.13276330167199 0.813884762905709 +234.17 13.7565528202972 3.13276437497815 0.81486531136185 +241.72 13.7574526178556 3.13276544750841 0.806498234430174 +252.47 13.7583524157234 3.13276651926276 0.803789011488162 +251.55 13.7592522139005 3.13276759024119 0.80512081326101 +237.25 13.7601520123866 3.13276866044371 0.814232250366112 +233.74 13.7610518111815 3.13276972987031 0.803784702743674 +243.18 13.761951610285 3.13277079852099 0.802483874844758 +251.37 13.7628514096968 3.13277186639575 0.805291632923857 +256.42 13.7637512094168 3.1327729334946 0.806215232181074 +271.25 13.7646510094446 3.13277399981752 0.797549845549003 +269.71 13.7655508097801 3.13277506536452 0.829189552056634 +263.05 13.7664506104231 3.1327761301356 0.827834956075784 +260.27 13.7673504113733 3.13277719413075 0.822786781525284 +261.81 13.7682502126304 3.13277825734998 0.823024514747957 +262.52 13.7691500141944 3.13277931979327 0.80490831432279 +254.22 13.7700498160649 3.13278038146064 0.796583492230049 +258.82 13.7709496182418 3.13278144235208 0.796521502555432 +248.41 13.7718494207248 3.13278250246758 0.808244347578742 +247.98 13.7727492235136 3.13278356180716 0.808753254709756 +245.18 13.7736490266081 3.13278462037079 0.815477836056882 +253.85 13.774548830008 3.13278567815849 0.811480610607248 +250.57 13.7754486337132 3.13278673517026 0.808711050827022 +248.03 13.7763484377233 3.13278779140609 0.812292685882193 +250.37 13.7772482420382 3.13278884686597 0.80124435963186 +253.34 13.7781480466577 3.13278990154992 0.802024581438111 +243.38 13.7790478515814 3.13279095545792 0.801540934358464 +238.51 13.7799476568093 3.13279200858998 0.814933488688222 +231.08 13.780847462341 3.1327930609461 0.811812548255525 +234.09 13.7817472681763 3.13279411252627 0.811407839265284 +239.92 13.7826470743151 3.13279516333049 0.822009413213363 +247.19 13.7835468807571 3.13279621335876 0.816818533096098 +257.55 13.784446687502 3.13279726261108 0.804853988005157 +259.75 13.7853464945497 3.13279831108745 0.801258116274536 +270.71 13.7862463018999 3.13279935878787 0.790711882816154 +259.47 13.7871461095524 3.13280040571234 0.793523405299896 +243.15 13.788045917507 3.13280145186085 0.810946443052405 +234.81 13.7889457257634 3.1328024972334 0.820319659881278 +230.83 13.7898455343215 3.13280354182999 0.810392426770842 +238.6 13.7907453431809 3.13280458565063 0.808840661082528 +237.62 13.7916451523416 3.13280562869531 0.814760279575538 +243.68 13.7925449618032 3.13280667096402 0.80922808021593 +250.43 13.7934447715655 3.13280771245677 0.814563409675233 +252.45 13.7943445816284 3.13280875317356 0.817190689933605 +248.88 13.7952443919915 3.13280979311438 0.808463923826195 +245.68 13.7961442026547 3.13281083227923 0.812546264114077 +239.13 13.7970440136177 3.13281187066812 0.793590886130014 +246.27 13.7979438248803 3.13281290828104 0.800108545569186 +240.03 13.7988436364423 3.13281394511798 0.801170232791617 +246.58 13.7997434483035 3.13281498117896 0.800737198801074 +246.9 13.8006432604636 3.13281601646396 0.807767851001551 +222.45 13.7115644476814 3.13180528523222 0.813249625929239 +224.02 13.7124642287092 3.13180639623491 0.82153827275063 +230.03 13.7133640100577 3.13180750646197 0.804422365169026 +222.9 13.7142637917266 3.13180861591341 0.814704257374189 +235.33 13.7151635737157 3.13180972458922 0.80943594947608 +232.77 13.7160633560248 3.13181083248942 0.820640235293255 +233.82 13.7169631386537 3.13181193961398 0.815066396017373 +237.3 13.7178629216022 3.13181304596292 0.817627994069801 +236.29 13.7187627048699 3.13181415153623 0.80945024813177 +230.6 13.7196624884568 3.13181525633391 0.818253226821224 +232.91 13.7205622723625 3.13181636035596 0.81971490770286 +233.51 13.7214620565869 3.13181746360238 0.815626447538384 +242.93 13.7223618411296 3.13181856607316 0.812727232825405 +245.96 13.7232616259906 3.13181966776831 0.813628246875047 +236.01 13.7241614111696 3.13182076868782 0.817723525083486 +230.95 13.7250611966663 3.13182186883169 0.815212534978327 +237.2 13.7259609824806 3.13182296819992 0.810356061477138 +233.26 13.7268607686121 3.13182406679252 0.818678023032629 +241.68 13.7277605550607 3.13182516460947 0.815984361062081 +246.01 13.7286603418262 3.13182626165077 0.821068530174812 +235.14 13.7295601289083 3.13182735791643 0.82124721468524 +232.93 13.7304599163068 3.13182845340645 0.814128611658797 +226.25 13.7313597040215 3.13182954812082 0.811190815440803 +232.06 13.7322594920522 3.13183064205954 0.81882043248533 +229.77 13.7331592803986 3.1318317352226 0.814654610434929 +222.23 13.7340590690605 3.13183282761002 0.823461300745585 +233.53 13.7349588580377 3.13183391922178 0.818582484632829 +242.87 13.73585864733 3.13183501005789 0.802870009922907 +240.03 13.7367584369371 3.13183610011835 0.823639565497882 +244.17 13.7376582268588 3.13183718940314 0.816434580794894 +239.58 13.7385580170949 3.13183827791228 0.811697905718037 +253.32 13.7394578076452 3.13183936564576 0.801619388759408 +248.42 13.7403575985094 3.13184045260358 0.814979397849617 +247.02 13.7412573896873 3.13184153878573 0.813976302852596 +254.31 13.7421571811788 3.13184262419222 0.814664538851745 +246.2 13.7430569729835 3.13184370882305 0.807289189786297 +243.05 13.7439567651012 3.13184479267821 0.802609986715637 +251.79 13.7448565575318 3.1318458757577 0.812267556433018 +238.35 13.745756350275 3.13184695806153 0.808693639219161 +228.52 13.7466561433305 3.13184803958968 0.799254991472283 +239.76 13.7475559366982 3.13184912034216 0.807055256551138 +236.01 13.7484557303779 3.13185020031897 0.811127511759265 +238.77 13.7493555243692 3.1318512795201 0.806422011027857 +238.23 13.7502553186721 3.13185235794556 0.810850744455288 +239.88 13.7511551132861 3.13185343559534 0.796535035991703 +244.62 13.7520549082112 3.13185451246944 0.803206034889203 +235.81 13.7529547034472 3.13185558856786 0.80906500531247 +233.53 13.7538544989937 3.13185666389061 0.817708072355564 +237.55 13.7547542948505 3.13185773843766 0.804568274761446 +239.75 13.7556540910175 3.13185881220904 0.800642844587299 +249.77 13.7565538874945 3.13185988520473 0.794188272706623 +244.23 13.7574536842811 3.13186095742473 0.797800917026503 +249.4 13.7583534813771 3.13186202886905 0.812675237322726 +246.58 13.7592532787824 3.13186309953768 0.794406185964955 +237.69 13.7601530764968 3.13186416943061 0.80067124498766 +252.86 13.7610528745199 3.13186523854786 0.809147818071229 +261.39 13.7619526728516 3.13186630688941 0.800370095404834 +254.19 13.7628524714916 3.13186737445527 0.802736880918966 +274.21 13.7637522704398 3.13186844124543 0.795622059545437 +268.1 13.7646520696958 3.1318695072599 0.811243901948021 +260.06 13.7655518692595 3.13187057249867 0.806295433105821 +251.41 13.7664516691307 3.13187163696173 0.824319041678423 +281.91 13.7673514693091 3.1318727006491 0.813207663401712 +269.84 13.7682512697945 3.13187376356077 0.807520253177881 +272.58 13.7691510705867 3.13187482569673 0.812210760316573 +260.76 13.7700508716854 3.13187588705698 0.804473617920757 +260.01 13.7709506730905 3.13187694764154 0.806434587716444 +253.09 13.7718504748017 3.13187800745038 0.811195781718372 +250.75 13.7727502768187 3.13187906648351 0.799122042269478 +251.41 13.7736500791414 3.13188012474094 0.808182367489707 +254.42 13.7745498817695 3.13188118222265 0.814800092509612 +248.85 13.7754496847029 3.13188223892865 0.815739406598234 +247.68 13.7763494879412 3.13188329485894 0.816837340457109 +248.83 13.7772492914843 3.13188435001351 0.792632912970311 +238.74 13.778149095332 3.13188540439236 0.802772031277094 +235.64 13.7790488994839 3.1318864579955 0.813429146440681 +232.65 13.7799487039399 3.13188751082292 0.808435817768694 +226.81 13.7808485086999 3.13188856287462 0.818659132379775 +234.72 13.7817483137634 3.13188961415059 0.807192682681677 +238.34 13.7826481191304 3.13189066465084 0.817405095479015 +242.55 13.7835479248005 3.13189171437537 0.815842330389784 +248.5 13.7844477307736 3.13189276332418 0.817096498083436 +250.71 13.7853475370495 3.13189381149725 0.803662173112927 +258.2 13.7862473436279 3.1318948588946 0.80336936056401 +257.91 13.7871471505086 3.13189590551622 0.803789272559681 +256.32 13.7880469576914 3.13189695136211 0.807087533001736 +251.21 13.788946765176 3.13189799643226 0.812323801852598 +228.26 13.7898465729622 3.13189904072668 0.820622945921721 +237.38 13.7907463810499 3.13190008424537 0.807612855951295 +241.25 13.7916461894387 3.13190112698832 0.810149385052393 +247.69 13.7925459981285 3.13190216895554 0.809834854250563 +257.47 13.793445807119 3.13190321014701 0.804376341069519 +252.66 13.79434561641 3.13190425056275 0.810958198410362 +246.57 13.7952454260013 3.13190529020274 0.816985229757296 +248.35 13.7961452358927 3.131906329067 0.79732154168693 +236.77 13.7970450460838 3.13190736715551 0.80671259619184 +231.41 13.7979448565746 3.13190840446827 0.808477778690545 +242.78 13.7988446673648 3.13190944100529 0.801828765347725 +250.16 13.7997444784542 3.13191047676656 0.814912794269647 +245.08 13.8006442898425 3.13191151175208 0.806018359806498 +230.97 13.7115655531446 3.1309008112416 0.807813990461049 +229.15 13.712465333401 3.1309019219228 0.809640380019817 +233.68 13.713365113978 3.13090303182861 0.80889009216502 +228.16 13.7142648948754 3.13090414095903 0.820506177984524 +235.98 13.7151646760931 3.13090524931404 0.814444127665321 +238.32 13.7160644576307 3.13090635689366 0.819711226710088 +234.36 13.7169642394881 3.13090746369787 0.820835815188217 +230.53 13.7178640216651 3.13090856972668 0.824091928974401 +234.8 13.7187638041613 3.13090967498009 0.813305069082707 +236.28 13.7196635869767 3.13091077945809 0.81674185992212 +228.24 13.7205633701109 3.13091188316069 0.821488099707185 +236.11 13.7214631535638 3.13091298608787 0.799454005934718 +238.38 13.7223629373351 3.13091408823965 0.819538660323613 +247.72 13.7232627214246 3.13091518961601 0.82063114815249 +238.77 13.724162505832 3.13091629021697 0.8142613379856 +238.82 13.7250622905572 3.13091739004251 0.813912495108859 +232.9 13.7259620756 3.13091848909263 0.82119175560179 +238.99 13.72686186096 3.13091958736734 0.812677896236932 +235.75 13.7277616466371 3.13092068486663 0.814034912219277 +238.2 13.7286614326311 3.1309217815905 0.809370407383458 +243.19 13.7295612189417 3.13092287753895 0.824450230119387 +230.25 13.7304610055687 3.13092397271198 0.799481005797625 +221.15 13.7313607925119 3.13092506710959 0.822409138922577 +239.35 13.7322605797711 3.13092616073177 0.811264504364078 +236.3 13.7331603673459 3.13092725357853 0.80509176024916 +231.15 13.7340601552363 3.13092834564985 0.817002413665058 +237.29 13.734959943442 3.13092943694575 0.815239619454077 +230.74 13.7358597319628 3.13093052746622 0.803769908754603 +245.43 13.7367595207983 3.13093161721126 0.801646665463193 +236.82 13.7376593099485 3.13093270618087 0.816195520010644 +251.34 13.7385590994131 3.13093379437504 0.811359178020742 +252.9 13.7394588891919 3.13093488179378 0.815181241733583 +253.66 13.7403586792846 3.13093596843708 0.806429619528969 +242.4 13.741258469691 3.13093705430494 0.810318670299809 +246.62 13.7421582604109 3.13093813939736 0.814890600564171 +243.39 13.7430580514441 3.13093922371435 0.811999079096939 +266.59 13.7439578427903 3.13094030725589 0.776155645820012 +249.25 13.7448576344494 3.13094139002198 0.814070406128168 +245.66 13.745757426421 3.13094247201264 0.81184690043241 +237.76 13.746657218705 3.13094355322784 0.812700029943729 +242.17 13.7475570113012 3.1309446336676 0.800265716479704 +235.94 13.7484568042093 3.13094571333191 0.814465360044657 +232.71 13.7493565974291 3.13094679222077 0.821532739039993 +238.24 13.7502563909604 3.13094787033418 0.806316306950633 +237 13.7511561848029 3.13094894767214 0.807110524404104 +239.51 13.7520559789565 3.13095002423464 0.811455718203237 +238.25 13.7529557734209 3.13095110002169 0.804214938812197 +229.58 13.7538555681958 3.13095217503328 0.818217364953372 +243.06 13.7547553632812 3.13095324926941 0.798645153344008 +243.52 13.7556551586766 3.13095432273009 0.813576463140667 +244.92 13.756554954382 3.1309553954153 0.793009189252065 +245.6 13.757454750397 3.13095646732505 0.807593081655396 +247.63 13.7583545467216 3.13095753845934 0.808189490128808 +246.27 13.7592543433553 3.13095860881816 0.807765724295578 +254.83 13.7601541402981 3.13095967840152 0.793425169199336 +251.07 13.7610539375497 3.13096074720941 0.809903112821639 +252.87 13.7619537351098 3.13096181524183 0.812080440438714 +254.99 13.7628535329783 3.13096288249878 0.820183771576933 +264.46 13.7637533311549 3.13096394898026 0.82855720483841 +258.51 13.7646531296394 3.13096501468627 0.825132775876944 +252.52 13.7655529284315 3.13096607961681 0.834016473690394 +276.23 13.7664527275311 3.13096714377187 0.818567010661034 +294 13.767352526938 3.13096820715145 0.796875394680341 +279.75 13.7682523266518 3.13096926975556 0.799489179966364 +279.08 13.7691521266724 3.13097033158418 0.805530567820528 +277.73 13.7700519269996 3.13097139263733 0.823374626548496 +262.93 13.7709517276331 3.13097245291499 0.817037367913173 +252.22 13.7718515285727 3.13097351241717 0.816430251080938 +242.34 13.7727513298182 3.13097457114387 0.810143063068649 +250.42 13.7736511313693 3.13097562909508 0.82 +246.38 13.7745509332259 3.13097668627081 0.815669161977118 +253.24 13.7754507353876 3.13097774267105 0.813625609936419 +252.46 13.7763505378544 3.13097879829579 0.813235651795783 +246.69 13.7772503406259 3.13097985314505 0.785111794274557 +245.54 13.778150143702 3.13098090721882 0.789615567311245 +230.69 13.7790499470823 3.13098196051709 0.809992806069928 +228.5 13.7799497507668 3.13098301303986 0.803377979951141 +226.7 13.7808495547551 3.13098406478714 0.815985070562417 +234.26 13.7817493590471 3.13098511575893 0.800833569039815 +237.45 13.7826491636424 3.13098616595521 0.817228601212896 +248.3 13.783548968541 3.130987215376 0.808139955730466 +249.52 13.7844487737425 3.13098826402128 0.808738942289281 +253.36 13.7853485792468 3.13098931189106 0.806925863991081 +258.93 13.7862483850536 3.13099035898534 0.803173448235352 +243.47 13.7871481911627 3.13099140530411 0.816933792943065 +248.28 13.7880479975739 3.13099245084738 0.805893173002632 +242.84 13.7889478042869 3.13099349561514 0.815451878271875 +230.95 13.7898476113016 3.13099453960739 0.813154847412843 +231.23 13.7907474186176 3.13099558282413 0.808747099767981 +242.22 13.7916472262349 3.13099662526535 0.810599373387534 +250.41 13.792547034153 3.13099766693107 0.805752682901078 +261.62 13.7934468423719 3.13099870782127 0.804261005232944 +263.05 13.7943466508914 3.13099974793596 0.8083663649269 +255.07 13.795246459711 3.13100078727513 0.820077621846612 +244.78 13.7961462688308 3.13100182583878 0.801562753709857 +233.53 13.7970460782504 3.13100286362691 0.807253828098804 +238.14 13.7979458879696 3.13100390063952 0.803751714064849 +239.89 13.7988456979881 3.13100493687661 0.816104384273744 +244.81 13.7997455083059 3.13100597233818 0.813697548181347 +246.66 13.8006453189226 3.13100700702422 0.821329452137868 +232.4 13.711566658287 3.12999633723494 0.81685665383293 +234.09 13.7124664377721 3.12999744759467 0.820649006476869 +226.66 13.7133662175779 3.12999855717924 0.822732020521643 +232.98 13.714265997704 3.12999966598862 0.809012361884319 +229.7 13.7151657781504 3.13000077402284 0.82536932600722 +229.06 13.7160655589168 3.13000188128188 0.819513622207327 +232.42 13.7169653400029 3.13000298776574 0.817332946494014 +234.45 13.7178651214086 3.13000409347442 0.824082691865494 +233.34 13.7187649031336 3.13000519840793 0.812260270272356 +234.61 13.7196646851777 3.13000630256625 0.816839680497801 +227.7 13.7205644675407 3.13000740594939 0.803593933880297 +236.47 13.7214642502223 3.13000850855734 0.811896790201465 +238.18 13.7223640332223 3.13000961039012 0.81355102290637 +239.48 13.7232638165405 3.1300107114477 0.821711094372899 +234.91 13.7241636001767 3.1300118117301 0.82030963081315 +238.69 13.7250633841306 3.1300129112373 0.819116675674053 +237.88 13.7259631684021 3.13001400996932 0.816194760320099 +236.44 13.7268629529908 3.13001510792615 0.812265855871928 +236.65 13.7277627378967 3.13001620510778 0.813202071892162 +240.17 13.7286625231194 3.13001730151421 0.810383300957587 +243.28 13.7295623086587 3.13001839714546 0.812325080319283 +233.04 13.7304620945144 3.1300194920015 0.813527810190587 +234.69 13.7313618806863 3.13002058608234 0.807996739351946 +243.79 13.7322616671742 3.13002167938799 0.801978637026526 +241.87 13.7331614539778 3.13002277191843 0.795487077847514 +228.15 13.7340612410969 3.13002386367367 0.791399866041527 +228.99 13.7349610285313 3.13002495465371 0.796321220278152 +230.58 13.7358608162807 3.13002604485854 0.808836666532534 +243.51 13.736760604345 3.13002713428816 0.813250130617471 +237.1 13.7376603927239 3.13002822294258 0.808202691508151 +248.87 13.7385601814172 3.13002931082179 0.81489615047308 +254.93 13.7394599704247 3.13003039792578 0.813089593476402 +257.38 13.740359759746 3.13003148425457 0.813963287226511 +243.08 13.7412595493812 3.13003256980814 0.81591170118247 +244.58 13.7421593393298 3.13003365458649 0.813500052219697 +245.64 13.7430591295916 3.13003473858963 0.81165127797818 +263.16 13.7439589201666 3.13003582181755 0.779715325762364 +255.34 13.7448587110543 3.13003690427025 0.809761551291215 +249.58 13.7457585022546 3.13003798594774 0.801531949360779 +249 13.7466582937674 3.13003906685 0.80025634212295 +240.58 13.7475580855922 3.13004014697704 0.805816622204957 +240.21 13.748457877729 3.13004122632885 0.810040035054802 +247.33 13.7493576701775 3.13004230490544 0.812505797967279 +245.65 13.7502574629375 3.1300433827068 0.813714500658266 +252.69 13.7511572560087 3.13004445973293 0.818509110831252 +243.76 13.752057049391 3.13004553598384 0.809898685651698 +236.55 13.752956843084 3.13004661145951 0.817068661199999 +233.12 13.7538566370877 3.13004768615995 0.813360382553253 +246.66 13.7547564314017 3.13004876008516 0.810922532238621 +240.69 13.7556562260258 3.13004983323513 0.793504538806906 +251.47 13.7565560209598 3.13005090560987 0.799230048072128 +239.57 13.7574558162036 3.13005197720936 0.815717534630493 +239.84 13.7583556117568 3.13005304803363 0.812160732226284 +237.84 13.7592554076192 3.13005411808265 0.81475926031946 +252.03 13.7601552037906 3.13005518735642 0.804913426488457 +247.43 13.7610550002709 3.13005625585496 0.813017795035056 +252 13.7619547970597 3.13005732357825 0.819199909273908 +245.56 13.7628545941568 3.1300583905263 0.818306631246626 +255.93 13.7637543915621 3.1300594566991 0.821104492472491 +255.83 13.7646541892752 3.13006052209665 0.819244597964215 +253.12 13.7655539872961 3.13006158671895 0.813891982182628 +267.06 13.7664537856243 3.130062650566 0.814107387669694 +293.63 13.7673535842598 3.1300637136378 0.78372208570009 +288.19 13.7682533832023 3.13006477593435 0.805929883709085 +276.73 13.7691531824516 3.13006583745564 0.811988922266176 +268.51 13.7700529820074 3.13006689820168 0.80581820270377 +263.78 13.7709527818696 3.13006795817246 0.819395635722801 +249.96 13.7718525820378 3.13006901736798 0.809580929740576 +233.37 13.7727523825119 3.13007007578824 0.823185227164001 +242.77 13.7736521832917 3.13007113343324 0.816010111964578 +240.29 13.7745519843769 3.13007219030298 0.814471595354384 +245.77 13.7754517857674 3.13007324639745 0.815713704324939 +241.56 13.7763515874628 3.13007430171666 0.819285162517084 +232.43 13.7772513894629 3.1300753562606 0.814572279846406 +227.67 13.7781511917676 3.13007641002928 0.817698932902695 +227.96 13.7790509943767 3.13007746302268 0.819472765188163 +228.66 13.7799507972898 3.13007851524082 0.829530603155597 +230.95 13.7808506005067 3.13007956668368 0.815922446975337 +238.87 13.7817504040273 3.13008061735127 0.812172937951657 +242.68 13.7826502078513 3.13008166724359 0.805103471215757 +238.88 13.7835500119785 3.13008271636063 0.810733077765178 +247.41 13.7844498164087 3.1300837647024 0.815618091653224 +252.83 13.7853496211416 3.13008481226888 0.804703746236693 +251.22 13.7862494261771 3.13008585906009 0.813139520216073 +245.58 13.7871492315148 3.13008690507602 0.812288748462746 +244.24 13.7880490371546 3.13008795031666 0.823042188104761 +246.66 13.7889488430963 3.13008899478203 0.82686842525412 +245.88 13.7898486493395 3.1300900384721 0.828369850386443 +233.37 13.7907484558842 3.1300910813869 0.822476998867752 +230.34 13.7916482627301 3.1300921235264 0.820486064998387 +247.26 13.7925480698769 3.13009316489062 0.801437440025067 +255.51 13.7934478773244 3.13009420547954 0.810742759682856 +266.04 13.7943476850724 3.13009524529318 0.802900902283666 +266.42 13.7952474931207 3.13009628433153 0.804324679113186 +242.21 13.7961473014691 3.13009732259458 0.812214622794965 +247.9 13.7970471101173 3.13009836008233 0.790966295653751 +247.01 13.7979469190651 3.13009939679479 0.801039891096176 +249.48 13.7988467283123 3.13010043273196 0.798916864314465 +247.26 13.7997465378587 3.13010146789382 0.814292784906441 +247.14 13.8006463477039 3.13010250228039 0.819213500486313 +225.71 13.7115677631086 3.12909186321226 0.824998083920627 +230.85 13.7124675418226 3.12909297325052 0.830787848868502 +231.6 13.7133673208573 3.12909408251383 0.828950898378842 +228.57 13.7142671002125 3.1290951910022 0.829419298986337 +228.04 13.7151668798878 3.12909629871561 0.834815369825831 +233.93 13.7160666598831 3.12909740565407 0.814289746532939 +231.99 13.7169664401982 3.12909851181758 0.818221849364729 +235.14 13.7178662208329 3.12909961720614 0.820772455571733 +230.33 13.7187660017868 3.12910072181974 0.814151068631355 +237.26 13.7196657830599 3.12910182565839 0.809422463756734 +230.33 13.7205655646518 3.12910292872207 0.822103904963887 +233.11 13.7214653465623 3.1291040310108 0.803737125598199 +236.29 13.7223651287913 3.12910513252456 0.809968325394736 +238.65 13.7232649113385 3.12910623326337 0.804020359257719 +234.91 13.7241646942036 3.12910733322721 0.80744602666082 +233.31 13.7250644773865 3.12910843241608 0.799856236265429 +238.05 13.7259642608869 3.12910953082999 0.806514507631826 +230.28 13.7268640447046 3.12911062846894 0.80577907524872 +231.84 13.7277638288394 3.12911172533291 0.814589362339088 +233.39 13.728663613291 3.12911282142191 0.815452313132305 +234.1 13.7295633980593 3.12911391673594 0.816510166131338 +231.44 13.7304631831439 3.129115011275 0.816439722296805 +237.13 13.7313629685448 3.12911610503909 0.80752787258698 +234.08 13.7322627542616 3.1291171980282 0.808372639201487 +234.46 13.7331625402941 3.12911829024233 0.792954498519997 +244.79 13.7340623266421 3.12911938168148 0.804068845018376 +233.35 13.7349621133055 3.12912047234565 0.816214665612256 +237.45 13.7358619002838 3.12912156223485 0.809683525909401 +255.5 13.7367616875771 3.12912265134906 0.810339395269636 +247.29 13.7376614751849 3.12912373968828 0.814192027759894 +250.23 13.7385612631071 3.12912482725252 0.81867840918592 +249.07 13.7394610513435 3.12912591404178 0.813099001943714 +246.62 13.7403608398938 3.12912700005605 0.81093931932964 +250.81 13.7412606287578 3.12912808529533 0.808904662398974 +253.45 13.7421604179354 3.12912916975961 0.814279780311072 +248.77 13.7430602074262 3.12913025344891 0.80690937234992 +254.46 13.74395999723 3.12913133636321 0.801517236871253 +245.26 13.7448597873467 3.12913241850252 0.812834326688481 +256.69 13.7457595777759 3.12913349986683 0.810598084561039 +258.35 13.7466593685176 3.12913458045615 0.810131477184841 +249.15 13.7475591595713 3.12913566027047 0.807212644762156 +250.39 13.748458950937 3.12913673930978 0.810855263157895 +249.61 13.7493587426144 3.1291378175741 0.804625466737789 +251.25 13.7502585346033 3.12913889506342 0.802029970611788 +245.96 13.7511583269034 3.12913997177773 0.8117866154031 +237.89 13.7520581195146 3.12914104771703 0.824225254644147 +242.36 13.7529579124366 3.12914212288133 0.823125167282749 +229.71 13.7538577056691 3.12914319727062 0.823611179127474 +234.18 13.754757499212 3.1291442708849 0.799634210290713 +236.24 13.7556572930651 3.12914534372417 0.810031209100977 +241.73 13.756557087228 3.12914641578844 0.812526422028831 +236.79 13.7574568817006 3.12914748707768 0.821513872406904 +237.82 13.7583566764827 3.12914855759192 0.811971875394123 +238.33 13.759256471574 3.12914962733113 0.813553750058705 +243.05 13.7601562669744 3.12915069629533 0.81964237723054 +249.65 13.7610560626835 3.12915176448451 0.81913591044254 +249.89 13.7619558587012 3.12915283189868 0.817409705841419 +243.19 13.7628556550272 3.12915389853782 0.814788975409221 +261.91 13.7637554516614 3.12915496440194 0.800428486997636 +256.9 13.7646552486034 3.12915602949103 0.812763063105891 +267.24 13.7655550458531 3.1291570938051 0.807950843627706 +257.19 13.7664548434103 3.12915815734415 0.797754561047871 +276.35 13.7673546412747 3.12915922010817 0.790878688765573 +274.58 13.7682544394461 3.12916028209715 0.79061124985135 +263.61 13.7691542379242 3.12916134331111 0.802810802739879 +266.49 13.7700540367089 3.12916240375004 0.804359178936679 +262.62 13.7709538358 3.12916346341393 0.813635508945709 +244.47 13.7718536351971 3.12916452230279 0.818349963494768 +228.45 13.7727534349001 3.12916558041662 0.823473834994362 +237.99 13.7736532349087 3.12916663775541 0.801104926407575 +241.6 13.7745530352228 3.12916769431916 0.807606033055555 +243.6 13.7754528358421 3.12916875010787 0.806499359256504 +244.88 13.7763526367664 3.12916980512154 0.809446432198491 +233.51 13.7772524379954 3.12917085936016 0.817770375050256 +236.14 13.778152239529 3.12917191282375 0.817574427166538 +232.77 13.7790520413669 3.12917296551229 0.825275536551455 +234.36 13.7799518435089 3.12917401742579 0.808449305766859 +231.61 13.7808516459547 3.12917506856423 0.812155724733585 +235.12 13.7817514487041 3.12917611892763 0.817586750483184 +242.46 13.782651251757 3.12917716851598 0.794578948456592 +237.78 13.7835510551131 3.12917821732928 0.80415142955453 +247.48 13.7844508587721 3.12917926536753 0.796575654893783 +243.5 13.7853506627339 3.12918031263072 0.80512788212091 +243.77 13.7862504669982 3.12918135911886 0.813623416717374 +240.74 13.7871502715648 3.12918240483194 0.805564565253507 +247.79 13.7880500764334 3.12918344976997 0.799479679924317 +238.43 13.7889498816039 3.12918449393294 0.817582027696732 +240.66 13.7898496870761 3.12918553732084 0.821284195626961 +238.77 13.7907494928496 3.12918657993369 0.82716185155451 +234.42 13.7916492989243 3.12918762177147 0.823230092601184 +238.7 13.7925491053 3.12918866283419 0.816287734773021 +259.48 13.7934489119763 3.12918970312184 0.803204253604138 +263.91 13.7943487189532 3.12919074263443 0.806785056422913 +266.53 13.7952485262304 3.12919178137195 0.805953348075235 +250.76 13.7961483338076 3.1291928193344 0.809071129707113 +250.21 13.7970481416846 3.12919385652178 0.805159755734968 +243.59 13.7979479498613 3.12919489293409 0.801534534851452 +246.05 13.7988477583373 3.12919592857133 0.802941712804715 +257 13.7997475671125 3.12919696343349 0.809960828203693 +249.26 13.8006473761866 3.12919799752058 0.820147882812251 +231.76 13.7115688676092 3.12818738917356 0.82453333902107 +235.85 13.7124686455524 3.12818849889035 0.829520576416794 +227.33 13.7133684238163 3.12818960783241 0.828551759997364 +229.83 13.7142682024007 3.12819071599975 0.830450142290384 +225.74 13.7151679813052 3.12819182339237 0.829025931575507 +221.27 13.7160677605297 3.12819293001025 0.82169987868397 +227.09 13.716967540074 3.12819403585341 0.817979325574364 +237.11 13.7178673199378 3.12819514092184 0.814202208928449 +245.35 13.7187671001209 3.12819624521554 0.806992996747443 +236.54 13.7196668806232 3.12819734873451 0.814365417762859 +227.53 13.7205666614443 3.12819845147874 0.802628607945468 +222.58 13.721466442584 3.12819955344824 0.798836865107695 +238.16 13.7223662240421 3.128200654643 0.802472213733091 +236.08 13.7232660058185 3.12820175506302 0.813250999412449 +231.16 13.7241657879128 3.12820285470831 0.811034142115086 +239.83 13.7250655703248 3.12820395357885 0.80376708015868 +235.42 13.7259653530544 3.12820505167466 0.8119375985652 +236.85 13.7268651361013 3.12820614899572 0.815329380488566 +239 13.7277649194652 3.12820724554203 0.813827334193145 +234.47 13.728664703146 3.1282083413136 0.817207979807195 +232.27 13.7295644871434 3.12820943631042 0.813391576833361 +235.51 13.7304642714573 3.1282105305325 0.825825149631007 +242.96 13.7313640560873 3.12821162397982 0.811478679821399 +244.35 13.7322638410332 3.12821271665239 0.792326771949458 +243.03 13.7331636262949 3.12821380855022 0.79577864636906 +246.46 13.7340634118721 3.12821489967328 0.787163267096898 +240.12 13.7349631977646 3.12821599002159 0.800795739731897 +246.22 13.7358629839721 3.12821707959515 0.802311785779155 +250.43 13.7367627704945 3.12821816839394 0.804224207961007 +247.64 13.7376625573315 3.12821925641798 0.816163151651193 +254.84 13.7385623444828 3.12822034366726 0.810904904765227 +258.51 13.7394621319484 3.12822143014177 0.807831744227504 +252.68 13.7403619197278 3.12822251584153 0.811436961958572 +244.32 13.741261707821 3.12822360076651 0.815867992265287 +248.08 13.7421614962277 3.12822468491673 0.819609699421219 +239.2 13.7430612849476 3.12822576829219 0.816534592424402 +235.08 13.7439610739806 3.12822685089287 0.812146495422018 +247.65 13.7448608633264 3.12822793271879 0.811811766310215 +259.73 13.7457606529848 3.12822901376993 0.801650970817347 +251.23 13.7466604429556 3.1282300940463 0.804403791985947 +252.64 13.7475602332385 3.1282311735479 0.799580761616397 +247.11 13.7484600238333 3.12823225227472 0.809039852227432 +241.62 13.7493598147399 3.12823333022677 0.816571533649318 +245.09 13.7502596059579 3.12823440740403 0.812925760238992 +250.09 13.7511593974872 3.12823548380652 0.818193418044553 +244.68 13.7520591893274 3.12823655943423 0.818465755400873 +240.55 13.7529589814785 3.12823763428716 0.811771350503543 +230.23 13.7538587739402 3.1282387083653 0.811854693857602 +237.17 13.7547585667122 3.12823978166865 0.805837319399492 +236.76 13.7556583597944 3.12824085419723 0.822064720693836 +239.82 13.7565581531865 3.12824192595101 0.811770153976768 +238.87 13.7574579468882 3.12824299693001 0.822130651883448 +243.45 13.7583577408994 3.12824406713421 0.822523554783573 +236.98 13.7592575352199 3.12824513656363 0.817255958452399 +240.25 13.7601573298493 3.12824620521825 0.80458243333266 +243.22 13.7610571247876 3.12824727309808 0.812364453798311 +242.09 13.7619569200344 3.12824834020311 0.817814796227913 +249.68 13.7628567155895 3.12824940653335 0.805730818704745 +253.68 13.7637565114528 3.12825047208879 0.799357663788105 +256.98 13.764656307624 3.12825153686943 0.80624363635027 +270.26 13.7655561041028 3.12825260087527 0.766174871158288 +259.07 13.7664559008891 3.12825366410631 0.797076316111004 +256.3 13.7673556979826 3.12825472656254 0.813839495996232 +255.75 13.768255495383 3.12825578824397 0.804634298685273 +255.32 13.7691552930903 3.1282568491506 0.807007342800701 +250.47 13.7700550911041 3.12825790928241 0.791390499158767 +246.33 13.7709548894242 3.12825896863942 0.805123752295622 +251.51 13.7718546880505 3.12826002722162 0.80975526625816 +237.51 13.7727544869826 3.12826108502901 0.817257041801129 +241.6 13.7736542862203 3.12826214206159 0.798880320240014 +237.9 13.7745540857635 3.12826319831935 0.80981160929264 +245.93 13.7754538856119 3.1282642538023 0.803507480303934 +256.49 13.7763536857653 3.12826530851043 0.804061059689858 +244.85 13.7772534862234 3.12826636244375 0.81181534853581 +229.93 13.7781532869861 3.12826741560224 0.812500746985168 +232.64 13.779053088053 3.12826846798592 0.81936193875139 +236.04 13.7799528894241 3.12826951959478 0.812341693766829 +234.93 13.780852691099 3.12827057042881 0.806860353724411 +237.96 13.7817524930776 3.12827162048802 0.813360854517058 +238.21 13.7826522953595 3.1282726697724 0.802625916513069 +244.5 13.7835520979447 3.12827371828196 0.806347007524478 +245.26 13.7844519008328 3.12827476601669 0.813696534593481 +232.39 13.7853517040237 3.12827581297659 0.808132943126701 +226.54 13.786251507517 3.12827685916166 0.820963616673195 +239.18 13.7871513113127 3.12827790457189 0.811621721319432 +242.53 13.7880511154104 3.1282789492073 0.80886335786705 +240.32 13.78895091981 3.12827999306787 0.808080288824653 +237.89 13.7898507245112 3.12828103615361 0.820160146832606 +244.61 13.7907505295138 3.12828207846451 0.809440411721781 +243.6 13.7916503348176 3.12828312000057 0.800527958940159 +241.22 13.7925501404223 3.12828416076179 0.803850324728593 +251.51 13.7934499463278 3.12828520074817 0.822520841109867 +254.23 13.7943497525337 3.12828623995971 0.825365754939829 +250.77 13.7952495590399 3.1282872783964 0.805038723811287 +238.72 13.7961493658462 3.12828831605825 0.803379552896471 +244.71 13.7970491729523 3.12828935294526 0.823070226137087 +235.98 13.797948980358 3.12829038905742 0.811565850831716 +244.07 13.7988487880631 3.12829142439473 0.822952922440568 +246.74 13.7997485960674 3.12829245895719 0.815694027410292 +244.13 13.8006484043706 3.1282934927448 0.809660344928612 +234.67 13.711569971789 3.12728291511885 0.831610868673556 +227.29 13.7124697489616 3.12728402451416 0.827727841373376 +231.02 13.7133695264549 3.12728513313498 0.825493303232249 +229.38 13.7142693042687 3.12728624098129 0.829527810595974 +228.62 13.7151690824026 3.12728734805311 0.82287487073423 +232.98 13.7160688608565 3.12728845435042 0.824687983311154 +230.64 13.7169686396302 3.12728955987323 0.817472106117655 +230.12 13.7178684187234 3.12729066462153 0.818382847803096 +234.8 13.718768198136 3.12729176859533 0.817678928291908 +222.65 13.7196679778676 3.12729287179462 0.808831432621713 +222.26 13.7205677579181 3.1272939742194 0.808039274322169 +226 13.7214675382872 3.12729507586967 0.808362043368084 +236.91 13.7223673189748 3.12729617674543 0.800176904487372 +232.31 13.7232670999805 3.12729727684667 0.817403820579815 +239.4 13.7241668813042 3.1272983761734 0.793820288063609 +234.79 13.7250666629457 3.12729947472562 0.813902467341653 +235.97 13.7259664449046 3.12730057250331 0.810910499745008 +235.62 13.7268662271809 3.12730166950649 0.814582841835298 +236.69 13.7277660097742 3.12730276573515 0.814254408849003 +240.26 13.7286657926844 3.12730386118929 0.808856776967953 +238.64 13.7295655759112 3.1273049558689 0.815420353384706 +243.06 13.7304653594544 3.12730604977399 0.804814182257327 +249.18 13.7313651433138 3.12730714290455 0.80141275411423 +240.27 13.7322649274892 3.12730823526059 0.793046080791867 +238.38 13.7331647119802 3.1273093268421 0.79194813115932 +237.14 13.7340644967868 3.12731041764908 0.79465491476058 +233.7 13.7349642819087 3.12731150768153 0.799696587027824 +251.6 13.7358640673456 3.12731259693945 0.798553088213698 +260.75 13.7367638530973 3.12731368542283 0.800086730268864 +254.97 13.7376636391637 3.12731477313168 0.794506505454068 +251.76 13.7385634255444 3.12731586006599 0.811419472247498 +256.51 13.7394632122393 3.12731694622577 0.810437706831739 +249.1 13.7403629992482 3.12731803161101 0.816416044525748 +244.61 13.7412627865707 3.1273191162217 0.822158953061894 +245.97 13.7421625742068 3.12732020005786 0.805570413091168 +239.6 13.7430623621561 3.12732128311947 0.805643901688962 +248.3 13.7439621504184 3.12732236540654 0.813635907965233 +260.12 13.7448619389936 3.12732344691906 0.811193240296241 +261.27 13.7457617278814 3.12732452765703 0.786530606000337 +245.86 13.7466615170815 3.12732560762046 0.795083635179683 +242.72 13.7475613065938 3.12732668680934 0.804257998810528 +254.06 13.748461096418 3.12732776522367 0.792108263559392 +243.77 13.7493608865539 3.12732884286344 0.80428811046017 +263.53 13.7502606770012 3.12732991972866 0.805613970924385 +271.38 13.7511604677598 3.12733099581933 0.799227854848236 +238.62 13.7520602588295 3.12733207113544 0.815163548685873 +242.99 13.7529600502099 3.12733314567699 0.806862942241043 +237.17 13.753859841901 3.12733421944398 0.813178950607786 +241.05 13.7547596339023 3.12733529243642 0.827524195889354 +238.13 13.7556594262138 3.12733636465429 0.810083947543619 +245.54 13.7565592188353 3.1273374360976 0.815740422908985 +241.23 13.7574590117664 3.12733850676634 0.819140296105328 +243.55 13.7583588050069 3.12733957666052 0.804621273726175 +234.33 13.7592585985567 3.12734064578014 0.814267322278925 +245.31 13.7601583924155 3.12734171412518 0.816629210110644 +258.55 13.7610581865831 3.12734278169566 0.801764145434429 +255.83 13.7619579810593 3.12734384849156 0.804998831696452 +256.41 13.7628577758437 3.12734491451289 0.800665851594094 +248.42 13.7637575709363 3.12734597975965 0.805985403123777 +251.34 13.7646573663368 3.12734704423184 0.813354479639338 +252.72 13.765557162045 3.12734810792945 0.778948932905397 +250.07 13.7664569580606 3.12734917085248 0.808306859262273 +245.55 13.7673567543834 3.12735023300093 0.81453744153973 +249.83 13.7682565510132 3.1273512943748 0.80703121667888 +238.19 13.7691563479498 3.1273523549741 0.808407710043932 +236.26 13.770056145193 3.12735341479881 0.820019175455417 +245.22 13.7709559427424 3.12735447384893 0.811271057363063 +238.4 13.771855740598 3.12735553212447 0.810901952092206 +241.05 13.7727555387594 3.12735658962543 0.801861092165145 +237.51 13.7736553372265 3.12735764635179 0.801270685579196 +238.34 13.774555135999 3.12735870230357 0.810899922420481 +242.07 13.7754549350767 3.12735975748076 0.807403889911161 +248.46 13.7763547344594 3.12736081188335 0.800887227856947 +242.79 13.7772545341469 3.12736186551135 0.793894358883531 +232.16 13.7781543341388 3.12736291836476 0.816849300588422 +244.29 13.7790541344351 3.12736397044357 0.813469620909197 +238.51 13.7799539350355 3.12736502174779 0.821073204081178 +236.78 13.7808537359397 3.12736607227741 0.808026939128846 +229.46 13.7817535371476 3.12736712203243 0.814454216785101 +232.94 13.7826533386588 3.12736817101284 0.820519625377411 +247.85 13.7835531404733 3.12736921921866 0.801855034811605 +247.97 13.7844529425907 3.12737026664987 0.813554795983764 +241.37 13.7853527450109 3.12737131330648 0.808253175362193 +236.72 13.7862525477336 3.12737235918848 0.813532035158572 +231.22 13.7871523507586 3.12737340429587 0.812843168191859 +232.47 13.7880521540856 3.12737444862866 0.819104473083371 +229.51 13.7889519577145 3.12737549218684 0.826077499728117 +234.81 13.789851761645 3.1273765349704 0.818461993919634 +242.08 13.7907515658769 3.12737757697935 0.806187582078612 +238.11 13.7916513704099 3.12737861821369 0.821494281358656 +253.6 13.792551175244 3.12737965867342 0.812624314387318 +262.65 13.7934509803787 3.12738069835853 0.811344085071806 +260.9 13.794350785814 3.12738173726902 0.817347821973347 +249.09 13.7952505915495 3.12738277540489 0.803472715481301 +248.67 13.796150397585 3.12738381276614 0.810329955520886 +244.84 13.7970502039204 3.12738484935277 0.816790339007711 +243.44 13.7979500105554 3.12738588516478 0.811827731971707 +249.64 13.7988498174898 3.12738692020216 0.819832697623198 +243.71 13.7997496247234 3.12738795446492 0.81100327559869 +241.76 13.8006494322558 3.12738898795305 0.812382019368008 +237.31 13.7115710756478 3.12637844104813 0.826794229185518 +232.69 13.7124708520501 3.12637955012197 0.836794997790427 +231.51 13.7133706287731 3.12638065842154 0.832689859548803 +231.01 13.7142704058164 3.12638176594683 0.826842553822211 +231.53 13.71517018318 3.12638287269785 0.828991532947877 +233.09 13.7160699608636 3.12638397867458 0.813062728094361 +232.79 13.7169697388669 3.12638508387704 0.82129572168753 +236.47 13.7178695171898 3.12638618830522 0.817257067483428 +225.07 13.7187692958319 3.12638729195912 0.813155510043196 +233.07 13.7196690747932 3.12638839483873 0.806493486059538 +228.15 13.7205688540733 3.12638949694406 0.817743708794471 +222.64 13.721468633672 3.1263905982751 0.82256020278834 +238.67 13.7223684135892 3.12639169883185 0.809034136797443 +232.97 13.7232681938246 3.12639279861432 0.799442188589475 +232.05 13.7241679743779 3.12639389762249 0.801589924966119 +231.32 13.725067755249 3.12639499585638 0.804095054759453 +237.69 13.7259675364375 3.12639609331597 0.816346901144451 +241.13 13.7268673179434 3.12639719000127 0.814704890132175 +234.44 13.7277670997664 3.12639828591227 0.808055709942132 +233.54 13.7286668819062 3.12639938104897 0.814250696113663 +236.33 13.7295666643626 3.12640047541138 0.799015047200824 +246.52 13.7304664471354 3.12640156899948 0.788358845122238 +243.53 13.7313662302244 3.12640266181329 0.798177578334738 +234.77 13.7322660136294 3.12640375385279 0.795772931635783 +238.49 13.73316579735 3.12640484511799 0.798300287988315 +238.47 13.7340655813862 3.12640593560889 0.803124209207138 +238.91 13.7349653657377 3.12640702532548 0.805806200054352 +243.23 13.7358651504042 3.12640811426776 0.807198287908546 +256.55 13.7367649353856 3.12640920243573 0.80707071429082 +252.21 13.7376647206815 3.12641028982939 0.81647472075862 +245.35 13.7385645062918 3.12641137644874 0.819887509587251 +257.16 13.7394642922163 3.12641246229377 0.807329343739504 +245.19 13.7403640784548 3.12641354736449 0.810315927148087 +248.33 13.7412638650069 3.1264146316609 0.800643451164485 +241.16 13.7421636518726 3.12641571518299 0.804207735408498 +243.73 13.7430634390515 3.12641679793076 0.795408418160245 +248.86 13.7439632265434 3.12641787990421 0.808566522250488 +252.02 13.7448630143482 3.12641896110334 0.807335424815398 +254.44 13.7457628024655 3.12642004152815 0.797366546940798 +248.56 13.7466625908952 3.12642112117863 0.788221086107645 +256.22 13.7475623796371 3.12642220005479 0.787448451447171 +241.83 13.7484621686909 3.12642327815662 0.789671941727438 +247.9 13.7493619580563 3.12642435548413 0.802274344846338 +251.33 13.7502617477333 3.1264254320373 0.815223635319183 +256.57 13.7511615377215 3.12642650781615 0.80063752276867 +238.76 13.7520613280207 3.12642758282066 0.818330952002963 +232.92 13.7529611186307 3.12642865705084 0.811110844893819 +233.25 13.7538609095513 3.12642973050669 0.80863402841957 +241.45 13.7547607007823 3.1264308031882 0.811656168233356 +244.45 13.7556604923234 3.12643187509537 0.800264309903362 +246.48 13.7565602841744 3.1264329462282 0.821430495060882 +248.8 13.757460076335 3.1264340165867 0.810099444853992 +248.94 13.7583598688052 3.12643508617085 0.807841695813139 +244.03 13.7592596615845 3.12643615498066 0.816906320022556 +252.48 13.7601594546729 3.12643722301613 0.804814192489547 +259.05 13.76105924807 3.12643829027725 0.799759626355905 +251.38 13.7619590417758 3.12643935676403 0.800325614771491 +247.42 13.7628588357898 3.12644042247646 0.815268149032703 +250.48 13.763758630112 3.12644148741454 0.820953931073526 +247.51 13.764658424742 3.12644255157827 0.803563176262489 +243.3 13.7655582196798 3.12644361496765 0.805127747876273 +251.63 13.7664580149249 3.12644467758267 0.812446017481699 +262.3 13.7673578104773 3.12644573942335 0.791298771379637 +248.67 13.7682576063367 3.12644680048966 0.815567667381463 +235.77 13.7691574025028 3.12644786078162 0.812831603678175 +237.67 13.7700571989755 3.12644892029922 0.816763694047651 +244.42 13.7709569957545 3.12644997904247 0.814443063736145 +233.22 13.7718567928396 3.12645103701135 0.815612766473342 +246.43 13.7727565902306 3.12645209420587 0.797666658778427 +245.29 13.7736563879272 3.12645315062602 0.804298424226193 +246.35 13.7745561859293 3.12645420627181 0.808065928972374 +241.1 13.7754559842365 3.12645526114324 0.809351409035216 +252.75 13.7763557828488 3.1264563152403 0.80079042057453 +235.58 13.7772555817658 3.12645736856299 0.80581887151826 +236.29 13.7781553809873 3.12645842111131 0.805590059582232 +245.44 13.7790551805131 3.12645947288526 0.81695040029447 +239.74 13.779954980343 3.12646052388483 0.809820188209809 +237.22 13.7808547804768 3.12646157411004 0.812860984357837 +236.61 13.7817545809142 3.12646262356086 0.812281330942419 +238.87 13.782654381655 3.12646367223732 0.818737278712115 +246.45 13.783554182699 3.12646472013939 0.796313367798214 +244.47 13.7844539840459 3.12646576726709 0.819167728807495 +243.24 13.7853537856956 3.1264668136204 0.802968370023363 +243.44 13.7862535876478 3.12646785919934 0.816691873437056 +244.77 13.7871533899023 3.12646890400389 0.809876457763782 +236.92 13.7880531924589 3.12646994803405 0.818313602319401 +235.72 13.7889529953173 3.12647099128984 0.803382134315817 +225.85 13.7898527984773 3.12647203377123 0.818909762858023 +238.8 13.7907526019388 3.12647307547824 0.813328241954778 +249.21 13.7916524057013 3.12647411641086 0.814919839789917 +252.85 13.7925522097649 3.12647515656908 0.809323498039451 +255.04 13.7934520141291 3.12647619595292 0.812085274601158 +244.89 13.7943518187939 3.12647723456236 0.818633631701803 +249.44 13.7952516237589 3.12647827239741 0.8213162559323 +235.96 13.796151429024 3.12647930945807 0.818824960759427 +233.13 13.7970512345889 3.12648034574432 0.8157406073724 +243.12 13.7979510404535 3.12648138125618 0.811447163977047 +237.32 13.7988508466173 3.12648241599364 0.814878648104342 +236.8 13.7997506530804 3.1264834499567 0.820646460622559 +243.14 13.8006504598424 3.12648448314535 0.815754077545899 +232.28 13.7115721791858 3.1254739669614 0.833136130992365 +232.25 13.712471954818 3.12547507571377 0.843473006302197 +231.52 13.7133717307708 3.12547618369209 0.81904876327211 +231.74 13.714271507044 3.12547729089636 0.831721655754205 +234.56 13.7151712836375 3.12547839732658 0.816017993058969 +236.58 13.7160710605509 3.12547950298274 0.812628413185243 +238.83 13.7169708377841 3.12548060786485 0.819894999219932 +238.72 13.7178706153368 3.1254817119729 0.81203637233788 +224.96 13.7187703932088 3.1254828153069 0.812200610834271 +220.34 13.7196701713999 3.12548391786684 0.814014871085074 +236.78 13.7205699499098 3.12548501965271 0.8098110700879 +230.65 13.7214697287384 3.12548612066453 0.818714296595323 +240.22 13.7223695078855 3.12548722090228 0.806377104638955 +233.01 13.7232692873507 3.12548832036597 0.810589017077252 +232.34 13.7241690671338 3.12548941905559 0.81852854655927 +234.9 13.7250688472347 3.12549051697114 0.823087406802761 +237.65 13.7259686276532 3.12549161411263 0.807048176862651 +232.99 13.7268684083889 3.12549271048004 0.812411841972315 +237.39 13.7277681894417 3.12549380607339 0.791083923408891 +244.32 13.7286679708113 3.12549490089266 0.798014906263922 +241.46 13.7295677524976 3.12549599493786 0.807508135750814 +243.92 13.7304675345002 3.12549708820898 0.805123423095585 +244.09 13.7313673168191 3.12549818070603 0.803675499261792 +236.65 13.7322670994538 3.125499272429 0.803764377831997 +240.85 13.7331668824044 3.12550036337789 0.794784388657552 +234.49 13.7340666656704 3.1255014535527 0.812496312466812 +242.46 13.7349664492517 3.12550254295343 0.814944804415647 +250.51 13.735866233148 3.12550363158007 0.81831179740139 +247.08 13.7367660173592 3.12550471943263 0.811662857079758 +247.54 13.7376658018849 3.1255058065111 0.81413220174383 +248.42 13.7385655867251 3.12550689281549 0.810404431369277 +245.38 13.7394653718794 3.12550797834579 0.809052689302198 +242.23 13.7403651573477 3.12550906310199 0.800305370645641 +246.38 13.7412649431297 3.12551014708411 0.805903713248214 +248.22 13.7421647292251 3.12551123029214 0.797878280290341 +243.9 13.7430645156338 3.12551231272606 0.80664443832022 +254.04 13.7439643023556 3.1255133943859 0.814711632803604 +235.81 13.7448640893901 3.12551447527164 0.81000409307498 +244.18 13.7457638767373 3.12551555538328 0.807384673676234 +240.53 13.7466636643968 3.12551663472082 0.814707308939885 +239.13 13.7475634523685 3.12551771328426 0.813949552681985 +252.06 13.7484632406521 3.12551879107359 0.800348475122305 +247.64 13.7493630292474 3.12551986808883 0.799184782608696 +245.85 13.7502628181541 3.12552094432996 0.817795843971734 +248.73 13.7511626073721 3.12552201979698 0.811677245954137 +234.26 13.7520623969012 3.1255230944899 0.825503305485197 +241.01 13.752962186741 3.12552416840871 0.812562267391927 +240.49 13.7538619768914 3.12552524155341 0.808323701227703 +245.08 13.7547617673521 3.12552631392399 0.800155889655837 +245.71 13.755661558123 3.12552738552047 0.794668808165961 +248.99 13.7565613492038 3.12552845634283 0.813485998497526 +249.12 13.7574611405943 3.12552952639107 0.820348218313036 +248.85 13.7583609322942 3.1255305956652 0.802283076244347 +250.98 13.7592607243033 3.12553166416521 0.813291874816618 +247.29 13.7601605166215 3.1255327318911 0.809519105836227 +241.65 13.7610603092484 3.12553379884287 0.811666666666667 +246.13 13.7619601021839 3.12553486502052 0.801938907051269 +243.91 13.7628598954278 3.12553593042405 0.821794646517894 +247.29 13.7637596889797 3.12553699505345 0.815409944023708 +248.93 13.7646594828396 3.12553805890873 0.792733986505613 +248.87 13.7655592770071 3.12553912198988 0.812986310891433 +254.34 13.766459071482 3.1255401842969 0.798798726937711 +259.66 13.7673588662642 3.12554124582979 0.799100810046122 +250.93 13.7682586613533 3.12554230658855 0.799737661148237 +246.37 13.7691584567492 3.12554336657317 0.814448492421243 +238.39 13.7700582524517 3.12554442578367 0.812596042274281 +249.56 13.7709580484605 3.12554548422003 0.790296746779101 +240.83 13.7718578447754 3.12554654188225 0.794241416600176 +240.84 13.7727576413961 3.12554759877034 0.80773161977355 +238.15 13.7736574383225 3.12554865488428 0.817823471104862 +246.36 13.7745572355543 3.12554971022409 0.813295119329832 +251.55 13.7754570330914 3.12555076478975 0.802988270413466 +248.94 13.7763568309334 3.12555181858128 0.806363891981003 +242.96 13.7772566290801 3.12555287159865 0.81167479286844 +242.73 13.7781564275314 3.12555392384189 0.803440696994134 +239 13.779056226287 3.12555497531097 0.810791975318309 +232.8 13.7799560253467 3.12555602600591 0.813202647496596 +236.09 13.7808558247102 3.1255570759267 0.812627590473245 +233.84 13.7817556243774 3.12555812507334 0.81230265790339 +241.6 13.7826554243479 3.12555917344583 0.807202418421032 +243.11 13.7835552246217 3.12556022104416 0.809254951907955 +242.68 13.7844550251984 3.12556126786834 0.80628459414124 +241.28 13.7853548260778 3.12556231391836 0.806111217739061 +233.96 13.7862546272598 3.12556335919423 0.807737101212401 +234.55 13.787154428744 3.12556440369594 0.81498438878842 +229.27 13.7880542305304 3.12556544742349 0.814953053246498 +226.73 13.7889540326185 3.12556649037687 0.814215733053408 +241.49 13.7898538350083 3.1255675325561 0.801020387388891 +245.79 13.7907536376995 3.12556857396116 0.811535021787529 +242.2 13.7916534406918 3.12556961459206 0.811345166686444 +250.26 13.7925532439851 3.12557065444879 0.812133846645465 +247.33 13.7934530475791 3.12557169353136 0.819527055357454 +240.48 13.7943528514736 3.12557273183975 0.820223305318397 +242.51 13.7952526556684 3.12557376937398 0.81133295859674 +236.01 13.7961524601632 3.12557480613403 0.820569393125814 +226.63 13.7970522649578 3.12557584211992 0.815437730013546 +241.18 13.7979520700521 3.12557687733162 0.815183418325383 +237.93 13.7988518754457 3.12557791176916 0.808643723549737 +231.57 13.7997516811385 3.12557894543252 0.812772600332612 +229.87 13.8006514871302 3.1255799783217 0.815567698651367 +229.66 13.711573282403 3.12456949285867 0.830757571948324 +236.43 13.7124730572652 3.12457060128957 0.819361493407196 +226.49 13.7133728324481 3.12457170894664 0.825253659772566 +228.53 13.7142726079514 3.12457281582989 0.826424710592899 +238.67 13.7151723837749 3.12457392193931 0.806517739816032 +236.67 13.7160721599184 3.1245750272749 0.818283689994216 +235.22 13.7169719363817 3.12457613183666 0.817156792641712 +223.48 13.7178717131645 3.12457723562459 0.815374744681456 +227.58 13.7187714902665 3.12457833863869 0.802580253098028 +223.69 13.7196712676877 3.12457944087895 0.810593002080638 +232.22 13.7205710454278 3.12458054234537 0.811042468288469 +233.3 13.7214708234864 3.12458164303796 0.812084773311872 +237.83 13.7223706018635 3.12458274295671 0.809540195277216 +240.46 13.7232703805588 3.12458384210162 0.814263590308948 +241.7 13.724170159572 3.12458494047269 0.82147822985142 +241.3 13.725069938903 3.12458603806991 0.804983934086966 +241.53 13.7259697185515 3.12458713489329 0.811100928943256 +238.47 13.7268694985173 3.12458823094283 0.82278317338084 +236.86 13.7277692788001 3.12458932621852 0.812616930165053 +239.01 13.7286690593998 3.12459042072036 0.820360443921958 +250.55 13.7295688403161 3.12459151444835 0.790092174936262 +247.54 13.7304686215489 3.12459260740249 0.799291084197149 +234.47 13.7313684030978 3.12459369958278 0.79601934198983 +231.53 13.7322681849626 3.12459479098922 0.80497005938702 +239.89 13.7331679671432 3.1245958816218 0.797664670903073 +242.92 13.7340677496392 3.12459697148052 0.806037186854128 +253.3 13.7349675324506 3.12459806056539 0.812705536565248 +251.42 13.735867315577 3.1245991488764 0.804908270315328 +244.33 13.7367670990182 3.12460023641355 0.810889075388815 +244.26 13.737666882774 3.12460132317683 0.803938556643095 +248.5 13.7385666668442 3.12460240916626 0.804767078636425 +243.19 13.7394664512286 3.12460349438182 0.805715322919148 +241.44 13.7403662359269 3.12460457882351 0.808517069012283 +250.02 13.7412660209389 3.12460566249134 0.799752634207835 +257.7 13.7421658062644 3.1246067453853 0.786105185788814 +252.91 13.7430655919031 3.12460782750539 0.820629616227837 +265.22 13.7439653778549 3.1246089088516 0.812673010976298 +249.77 13.7448651641195 3.12460998942395 0.816522099796224 +240.36 13.7457649506967 3.12461106922242 0.816557208595809 +243.18 13.7466647375863 3.12461214824702 0.80619755138045 +249.9 13.747564524788 3.12461322649774 0.792714929993557 +248.69 13.7484643123016 3.12461430397459 0.800407902103495 +246.45 13.7493641001269 3.12461538067755 0.802588957697059 +257.15 13.7502638882637 3.12461645660664 0.795149099569835 +253.64 13.7511636767117 3.12461753176184 0.806660852501908 +236.65 13.7520634654708 3.12461860614316 0.824245185277715 +235.28 13.7529632545406 3.1246196797506 0.81289781456746 +233.55 13.7538630439211 3.12462075258415 0.815603792197708 +235.86 13.7547628336118 3.12462182464381 0.806729764960206 +239.83 13.7556626236128 3.12462289592959 0.802462524594819 +238.34 13.7565624139236 3.12462396644148 0.810013937170594 +245.58 13.757462204544 3.12462503617947 0.804992782609038 +245 13.758361995474 3.12462610514358 0.801949866166501 +246.37 13.7592617867131 3.12462717333379 0.813784682687122 +241.23 13.7601615782613 3.1246282407501 0.818676357641946 +242.93 13.7610613701183 3.12462930739252 0.822100823159968 +247.88 13.7619611622838 3.12463037326104 0.806455662927608 +245.16 13.7628609547576 3.12463143835567 0.817534720937632 +247.16 13.7637607475396 3.12463250267639 0.800023630420228 +246.01 13.7646605406294 3.12463356622321 0.805739302335818 +250.93 13.7655603340269 3.12463462899613 0.810529293269065 +253.12 13.7664601277319 3.12463569099515 0.798133715998192 +248.42 13.7673599217441 3.12463675222026 0.809676153458038 +242.43 13.7682597160632 3.12463781267146 0.809244799357377 +247.22 13.7691595106891 3.12463887234876 0.811637569637234 +233.72 13.7700593056216 3.12463993125215 0.81197813223039 +251.41 13.7709591008604 3.12464098938162 0.796640485881455 +247.25 13.7718588964053 3.12464204673719 0.80551677061032 +245.51 13.772758692256 3.12464310331884 0.80343940166714 +246.8 13.7736584884124 3.12464415912658 0.802309497780233 +255.33 13.7745582848742 3.1246452141604 0.805862347441337 +255.85 13.7754580816412 3.1246462684203 0.802956905166955 +245.79 13.7763578787132 3.12464732190629 0.80613882318942 +237.42 13.77725767609 3.12464837461836 0.812708555200568 +232.95 13.7781574737712 3.1246494265565 0.81203835819136 +235.38 13.7790572717568 3.12465047772073 0.803569555499972 +229.76 13.7799570700465 3.12465152811103 0.818469852258142 +243.96 13.78085686864 3.1246525777274 0.812983050467206 +247.61 13.7817566675371 3.12465362656985 0.80054433120766 +238.68 13.7826564667377 3.12465467463837 0.818908072231388 +238.78 13.7835562662414 3.12465572193297 0.812426793272009 +236.99 13.7844560660481 3.12465676845363 0.819492192353891 +243.93 13.7853558661575 3.12465781420036 0.812924638664172 +235.56 13.7862556665695 3.12465885917316 0.804354731699471 +240.11 13.7871554672837 3.12465990337203 0.81335850837857 +229.24 13.7880552683 3.12466094679696 0.820108738476085 +232.76 13.7889550696181 3.12466198944795 0.809765913790172 +246.81 13.7898548712379 3.12466303132501 0.798168027912765 +244.98 13.790754673159 3.12466407242813 0.807929332053787 +250.9 13.7916544753813 3.12466511275731 0.812573421303445 +252.05 13.7925542779046 3.12466615231254 0.80531274525344 +250.41 13.7934540807285 3.12466719109384 0.815467620447691 +244.71 13.794353883853 3.12466822910119 0.80953043424495 +240.65 13.7952536872777 3.12466926633459 0.789998146869051 +235.33 13.7961534910025 3.12467030279405 0.809349451584357 +231.48 13.7970532950271 3.12467133847956 0.796117090489198 +240.99 13.7979530993513 3.12467237339112 0.812372451926409 +232.34 13.7988529039749 3.12467340752873 0.815980194617559 +227.23 13.7997527088977 3.12467444089239 0.824279822958051 +228.24 13.8006525141193 3.12467547348209 0.822636230252158 +226.97 13.7115743852992 3.12366501873995 0.828899835796388 +233.44 13.7124741593918 3.12366612684938 0.823575092696906 +231.2 13.713373933805 3.1236672341852 0.826352650869108 +230.12 13.7142737085386 3.12366834074743 0.831958663628486 +243.19 13.7151734835924 3.12366944653605 0.815726167250964 +234.32 13.7160732589662 3.12367055155107 0.824586855505361 +238.98 13.7169730346598 3.12367165579248 0.816261056196297 +234.27 13.7178728106728 3.12367275926029 0.825056329354324 +230.34 13.7187725870052 3.12367386195448 0.830032759471956 +236.48 13.7196723636567 3.12367496387507 0.824978216671507 +238.61 13.720572140627 3.12367606502204 0.818508628917551 +236.3 13.721471917916 3.12367716539541 0.810890879321969 +237.8 13.7223716955234 3.12367826499515 0.822909855871734 +239.97 13.723271473449 3.12367936382129 0.819377056596065 +239.54 13.7241712516925 3.1236804618738 0.814139922064633 +241.31 13.7250710302537 3.1236815591527 0.809514456761912 +249.57 13.7259708091325 3.12368265565797 0.81316743447007 +238.34 13.7268705883286 3.12368375138963 0.814089365768762 +241.95 13.7277703678417 3.12368484634766 0.812956706799816 +242.3 13.7286701476717 3.12368594053207 0.807867894803418 +246.93 13.7295699278183 3.12368703394286 0.79951965520033 +242.35 13.7304697082813 3.12368812658002 0.791364217081777 +237.56 13.7313694890605 3.12368921844355 0.794726412895061 +240.34 13.7322692701556 3.12369030953345 0.799302824597369 +238.56 13.7331690515665 3.12369139984973 0.803249855412332 +245.36 13.7340688332928 3.12369248939237 0.805050357173692 +247.16 13.7349686153344 3.12369357816137 0.806163364368499 +246.8 13.7358683976911 3.12369466615675 0.81397342794316 +236.5 13.7367681803626 3.12369575337848 0.815680227730993 +238.59 13.7376679633487 3.12369683982658 0.811089164252722 +246.79 13.7385677466492 3.12369792550104 0.810514732760277 +248.74 13.7394675302638 3.12369901040187 0.82935521974665 +247.3 13.7403673141924 3.12370009452905 0.809947357468226 +251.3 13.7412670984346 3.12370117788259 0.795037442988664 +251.66 13.7421668829904 3.12370226046248 0.789353427120839 +257.63 13.7430666678594 3.12370334226873 0.806916512059369 +258.52 13.7439664530415 3.12370442330133 0.822413893344368 +265.24 13.7448662385363 3.12370550356029 0.810382290299679 +249.78 13.7457660243438 3.1237065830456 0.804941334886641 +245.81 13.7466658104636 3.12370766175725 0.806652719824133 +244.2 13.7475655968956 3.12370873969526 0.800085897425508 +253.49 13.7484653836394 3.12370981685961 0.798675622134001 +251.95 13.749365170695 3.1237108932503 0.805043650599277 +251.55 13.7502649580621 3.12371196886734 0.795771666875706 +238.82 13.7511647457403 3.12371304371073 0.802212013203428 +227.89 13.7520645337296 3.12371411778045 0.802661549372158 +228.51 13.7529643220297 3.12371519107652 0.811907418855019 +236.86 13.7538641106404 3.12371626359892 0.818043424775495 +235.98 13.7547638995614 3.12371733534767 0.808274296449959 +242.13 13.7556636887926 3.12371840632274 0.786998883036801 +235.59 13.7565634783336 3.12371947652416 0.815609364214599 +233.96 13.7574632681844 3.1237205459519 0.811726381789358 +243.03 13.7583630583445 3.12372161460598 0.811706166349986 +236.84 13.7592628488139 3.12372268248639 0.825573251759037 +240.32 13.7601626395923 3.12372374959313 0.823249020875871 +242.53 13.7610624306795 3.1237248159262 0.807672062906576 +256.94 13.7619622220753 3.1237258814856 0.799656949519769 +249.25 13.7628620137794 3.12372694627132 0.806910709224747 +254.65 13.7637618057916 3.12372801028337 0.790779343390651 +248.95 13.7646615981116 3.12372907352174 0.802085047790708 +252.5 13.7655613907394 3.12373013598643 0.801383581241304 +243.81 13.7664611836746 3.12373119767744 0.807415784162436 +228.53 13.767360976917 3.12373225859477 0.812350410731539 +233.86 13.7682607704663 3.12373331873842 0.820853463650487 +235.9 13.7691605643225 3.12373437810838 0.816590068463208 +242.12 13.7700603584852 3.12373543670466 0.808040028264232 +254.99 13.7709601529542 3.12373649452726 0.797456157986776 +249.38 13.7718599477293 3.12373755157616 0.791656647235881 +237.33 13.7727597428102 3.12373860785138 0.816282021080149 +246.23 13.7736595381969 3.12373966335291 0.809052323007161 +250.05 13.7745593338889 3.12374071808075 0.808768516004465 +252.19 13.7754591298861 3.1237417720349 0.803214440631017 +241.43 13.7763589261883 3.12374282521535 0.816649200693558 +240.66 13.7772587227953 3.1237438776221 0.81318883314824 +229.79 13.7781585197068 3.12374492925516 0.805409249138009 +234.79 13.7790583169226 3.12374598011452 0.811764616373686 +227.51 13.7799581144424 3.12374703020019 0.815254841858113 +233.34 13.7808579122661 3.12374807951215 0.822653130718196 +244.05 13.7817577103935 3.12374912805041 0.815605284281438 +228.88 13.7826575088243 3.12375017581497 0.82353711117955 +233.5 13.7835573075582 3.12375122280582 0.819695115338735 +241.65 13.7844571065951 3.12375226902297 0.804644981647893 +236.79 13.7853569059347 3.12375331446641 0.804475116671553 +240.88 13.7862567055769 3.12375435913615 0.801553341622128 +243.87 13.7871565055213 3.12375540303217 0.807519421125172 +240.03 13.7880563057678 3.12375644615448 0.799636316822761 +235.77 13.7889561063161 3.12375748850308 0.812647884657854 +241.74 13.789855907166 3.12375853007797 0.80570823177046 +254.11 13.7907557083174 3.12375957087915 0.799727123249332 +246.63 13.7916555097699 3.12376061090661 0.81325083823242 +247.63 13.7925553115233 3.12376165016035 0.802497728241377 +246.89 13.7934551135775 3.12376268864037 0.805670684261509 +240.76 13.7943549159321 3.12376372634667 0.803390998633919 +239.15 13.7952547185871 3.12376476327925 0.81219576397374 +234.26 13.796154521542 3.12376579943812 0.820033429122117 +234.5 13.7970543247968 3.12376683482325 0.816976765856992 +232.92 13.7979541283512 3.12376786943466 0.811888530080134 +233.72 13.798853932205 3.12376890327235 0.803237908983418 +228.94 13.7997537363579 3.12376993633631 0.810203139801313 +228.81 13.8006535408098 3.12377096862654 0.810495999256756 +224.84 13.7115754878746 3.12276054460523 0.823916917963257 +230.89 13.7124752611977 3.12276165239319 0.819445917084476 +235.04 13.7133750348414 3.12276275940777 0.824766667840665 +239.61 13.7142748088055 3.12276386564898 0.823910452780804 +233.91 13.7151745830899 3.1227649711168 0.820804116885853 +228.88 13.7160743576942 3.12276607581125 0.817389022658517 +240.1 13.7169741326183 3.12276717973231 0.83037741895036 +242.03 13.7178739078619 3.12276828288 0.821201232032854 +239.74 13.7187736834248 3.12276938525429 0.828001804176879 +231.57 13.7196734593068 3.1227704868552 0.82080046319751 +235.94 13.7205732355077 3.12277158768273 0.827596286842818 +233.37 13.7214730120272 3.12277268773686 0.810627802863798 +241.98 13.7223727888651 3.12277378701761 0.812064787263413 +238.22 13.7232725660212 3.12277488552497 0.823904035367518 +245.74 13.7241723434952 3.12277598325893 0.813807883322728 +251.39 13.725072121287 3.1227770802195 0.81622109645383 +238.68 13.7259718993963 3.12277817640667 0.798789843239041 +241.69 13.7268716778229 3.12277927182045 0.787493427830094 +248.54 13.7277714565665 3.12278036646083 0.813486084762308 +242.86 13.728671235627 3.12278146032781 0.809854844681542 +242.17 13.7295710150041 3.12278255342139 0.800927611479588 +240.78 13.7304707946976 3.12278364574156 0.794163064248667 +237.46 13.7313705747073 3.12278473728834 0.800116322612 +238 13.7322703550329 3.12278582806171 0.804834406923027 +235.76 13.7331701356743 3.12278691806167 0.802885003471045 +245.64 13.7340699166311 3.12278800728823 0.798669300992558 +243.42 13.7349696979032 3.12278909574138 0.807671779639385 +233.77 13.7358694794904 3.12279018342112 0.800583995923352 +237.36 13.7367692613924 3.12279127032744 0.810691181477698 +237.08 13.737669043609 3.12279235646036 0.824826937198343 +252.13 13.7385688261399 3.12279344181986 0.800411168840878 +246.04 13.7394686089851 3.12279452640594 0.80131279776969 +247.91 13.7403683921441 3.12279561021861 0.788111433430029 +245.65 13.7412681756169 3.12279669325786 0.800063246106412 +250.2 13.7421679594031 3.12279777552369 0.79688388490845 +251.29 13.7430677435026 3.1227988570161 0.807934647912634 +253.58 13.7439675279152 3.12279993773509 0.810209949307348 +248.47 13.7448673126405 3.12280101768066 0.813893385795904 +249.37 13.7457670976785 3.1228020968528 0.810141268497709 +241.71 13.7466668830288 3.12280317525151 0.815848404587876 +251.46 13.7475666686912 3.1228042528768 0.801399413790073 +252.96 13.7484664546656 3.12280532972865 0.80743332135088 +253.4 13.7493662409516 3.12280640580708 0.801692729807937 +231.76 13.7502660275491 3.12280748111208 0.811728579213454 +226.29 13.7511658144579 3.12280855564364 0.795461120432969 +233.45 13.7520656016777 3.12280962940177 0.801160667383746 +233.88 13.7529653892083 3.12281070238647 0.816334069527081 +234.85 13.7538651770494 3.12281177459773 0.802690060426481 +231.22 13.7547649652009 3.12281284603555 0.812203679667852 +227.47 13.7556647536625 3.12281391669993 0.817881592341345 +228.36 13.756564542434 3.12281498659087 0.804940909449915 +228.76 13.7574643315152 3.12281605570837 0.822355357884668 +232.54 13.7583641209059 3.12281712405243 0.82494980216146 +237.73 13.7592639106057 3.12281819162304 0.806852939892965 +234.92 13.7601637006146 3.1228192584202 0.810783015064627 +239.45 13.7610634909323 3.12282032444392 0.819941267166537 +249.31 13.7619632815585 3.12282138969419 0.817712638046905 +254.06 13.762863072493 3.12282245417101 0.816474608336664 +252.24 13.7637628637357 3.12282351787438 0.804145321746918 +242.73 13.7646626552862 3.1228245808043 0.805463917947209 +241.02 13.7655624471444 3.12282564296076 0.813637237191067 +240.85 13.76646223931 3.12282670434377 0.805552543543652 +226.67 13.7673620317829 3.12282776495332 0.828887785650885 +221.43 13.7682618245627 3.12282882478941 0.819045827044642 +227.3 13.7691616176493 3.12282988385205 0.820775350577816 +236.41 13.7700614110424 3.12283094214122 0.815110378125518 +245.73 13.7709612047419 3.12283199965693 0.809077555816686 +249.7 13.7718609987474 3.12283305639919 0.804590416680565 +247.69 13.7727607930588 3.12283411236797 0.798693654350055 +244.99 13.7736605876759 3.12283516756329 0.812250810044171 +245.92 13.7745603825984 3.12283622198515 0.803830841681249 +255.73 13.775460177826 3.12283727563353 0.803778051173438 +252.04 13.7763599733587 3.12283832850845 0.798188239393123 +230.42 13.7772597691961 3.12283938060989 0.817372453112584 +238.17 13.778159565338 3.12284043193787 0.819541465162099 +234.07 13.7790593617842 3.12284148249237 0.816402754542271 +231.61 13.7799591585345 3.12284253227339 0.811946150623315 +232.04 13.7808589555887 3.12284358128094 0.82552904948892 +234.85 13.7817587529465 3.12284462951502 0.826128775687624 +237.32 13.7826585506076 3.12284567697561 0.806701264515926 +227.37 13.783558348572 3.12284672366272 0.813065613163361 +237.49 13.7844581468393 3.12284776957636 0.814938154138915 +247.25 13.7853579454094 3.12284881471651 0.800498497812673 +249.95 13.786257744282 3.12284985908318 0.803387770367138 +250.19 13.7871575434568 3.12285090267636 0.80394670785866 +255.08 13.7880573429337 3.12285194549606 0.803586019764735 +242.51 13.7889571427125 3.12285298754227 0.815182435536613 +242.59 13.7898569427928 3.12285402881499 0.805603619850689 +252.77 13.7907567431746 3.12285506931422 0.809691774195949 +248.27 13.7916565438575 3.12285610903996 0.812014392042584 +241.17 13.7925563448414 3.1228571479922 0.81252763791806 +252.92 13.7934561461259 3.12285818617096 0.800557222290477 +246.02 13.794355947711 3.12285922357621 0.80169844823593 +242.06 13.7952557495963 3.12286026020798 0.819768891235171 +250.7 13.7961555517817 3.12286129606624 0.815581084287222 +251.11 13.7970553542669 3.122862331151 0.830628694945913 +246.4 13.7979551570517 3.12286336546227 0.804172436966054 +242.74 13.7988549601359 3.12286439900003 0.814848989922936 +232.7 13.7997547635192 3.12286543176429 0.825115654379943 +222.35 13.8006545672015 3.12286646375505 0.825375160300878 +226.77 13.7115765901291 3.12185607045453 0.834746708324035 +225.91 13.7124763626829 3.12185717792102 0.820695093614464 +227.34 13.7133761355574 3.12185828461436 0.822270066100094 +237.42 13.7142759087523 3.12185939053454 0.825424369762749 +233.32 13.7151756822674 3.12186049568157 0.831983523004957 +230.37 13.7160754561025 3.12186160005545 0.819918553811013 +233.6 13.7169752302573 3.12186270365616 0.82067280389754 +239.02 13.7178750047317 3.12186380648372 0.814752762180764 +235.19 13.7187747795254 3.12186490853812 0.824018515965667 +237.21 13.7196745546381 3.12186600981936 0.832127473888686 +246.4 13.7205743300697 3.12186711032743 0.827453281107104 +242.63 13.7214741058199 3.12186821006234 0.813218985657253 +243.87 13.7223738818886 3.12186930902409 0.815431063401543 +248.67 13.7232736582754 3.12187040721267 0.814369982862812 +251.29 13.7241734349802 3.12187150462808 0.799542158375532 +243.12 13.7250732120027 3.12187260127032 0.807717432758497 +232.73 13.7259729893427 3.12187369713939 0.808498474075386 +250.69 13.7268727670001 3.12187479223529 0.796868956409966 +252.65 13.7277725449744 3.12187588655801 0.800830974616677 +251.09 13.7286723232657 3.12187698010756 0.806078805400733 +253.8 13.7295721018735 3.12187807288394 0.79310694848951 +245.97 13.7304718807977 3.12187916488713 0.801495501810959 +245.15 13.7313716600381 3.12188025611715 0.804224113099733 +240.77 13.7322714395945 3.12188134657399 0.797053631819457 +241.18 13.7331712194666 3.12188243625765 0.805310016151233 +244.99 13.7340709996541 3.12188352516812 0.795976151375664 +245.99 13.734970780157 3.12188461330541 0.788931223336553 +234.19 13.7358705609749 3.12188570066951 0.809111988469011 +243.49 13.7367703421076 3.12188678726043 0.805662379751458 +237.02 13.7376701235549 3.12188787307816 0.824740465288905 +247.7 13.7385699053166 3.1218889581227 0.790419758004282 +246.26 13.7394696873924 3.12189004239405 0.784495048907917 +245.36 13.7403694697822 3.1218911258922 0.801213023373662 +246.11 13.7412692524857 3.12189220861717 0.804607183158878 +243.71 13.7421690355026 3.12189329056893 0.803185616175538 +254.26 13.7430688188328 3.1218943717475 0.804672716447795 +250.44 13.7439686024761 3.12189545215288 0.811276778320287 +246.5 13.7448683864322 3.12189653178505 0.818010601395617 +243.57 13.7457681707008 3.12189761064403 0.821982212777107 +246.23 13.7466679552818 3.1218986887298 0.810463701500608 +239.77 13.747567740175 3.12189976604237 0.818509606430609 +242.04 13.74846752538 3.12190084258174 0.812284809254924 +246.77 13.7493673108968 3.1219019183479 0.807423325169062 +232.07 13.750267096725 3.12190299334085 0.808619448072158 +227.93 13.7511668828644 3.1219040675606 0.810390626608735 +237.25 13.7520666693149 3.12190514100713 0.803527484726395 +242.42 13.7529664560762 3.12190621368046 0.811787837150514 +252.95 13.753866243148 3.12190728558057 0.800759804489333 +232.86 13.7547660305302 3.12190835670747 0.803699178496214 +233.18 13.7556658182225 3.12190942706116 0.816310654059473 +227.86 13.7565656062247 3.12191049664163 0.811216353356207 +228.17 13.7574653945366 3.12191156544888 0.81482440795215 +234.2 13.758365183158 3.12191263348291 0.820279685535312 +233.6 13.7592649720885 3.12191370074372 0.815729017462138 +231.41 13.7601647613281 3.12191476723131 0.817503159274225 +247.71 13.7610645508764 3.12191583294568 0.818986047293511 +261.45 13.7619643407333 3.12191689788683 0.803453983506423 +268.76 13.7628641308985 3.12191796205474 0.785621358674133 +255.89 13.7637639213719 3.12191902544944 0.790671376925236 +245.11 13.7646637121531 3.1219200880709 0.809110367247095 +223.66 13.765563503242 3.12192114991914 0.820056632163435 +230.57 13.7664632946383 3.12192221099414 0.820353409408673 +221.8 13.7673630863418 3.12192327129591 0.824397111029502 +220.59 13.7682628783523 3.12192433082445 0.817446398382076 +219.81 13.7691626706696 3.12192538957976 0.815659482537718 +235.27 13.7700624632934 3.12192644756183 0.801108327025287 +242.06 13.7709622562235 3.12192750477066 0.796967607477939 +232.03 13.7718620494597 3.12192856120625 0.811769646361456 +241.58 13.7727618430018 3.12192961686861 0.801031074697088 +240.56 13.7736616368495 3.12193067175772 0.812893537223095 +244.57 13.7745614310026 3.12193172587359 0.8140560744835 +250.47 13.775461225461 3.12193277921622 0.806464403083516 +245.44 13.7763610202243 3.1219338317856 0.809386741582521 +226.64 13.7772608152924 3.12193488358174 0.822233612436074 +224.25 13.7781606106649 3.12193593460462 0.830170393996666 +238.33 13.7790604063418 3.12193698485426 0.815038204796101 +246.67 13.7799602023228 3.12193803433065 0.818866449319191 +254.91 13.7808599986076 3.12193908303379 0.815526318634393 +258.16 13.781759795196 3.12194013096368 0.808356886748302 +257.24 13.7826595920879 3.12194117812031 0.784517384336537 +225.95 13.7835593892829 3.12194222450368 0.818648856922682 +242 13.7844591867809 3.1219432701138 0.806454387302332 +244.61 13.7853589845816 3.12194431495066 0.804968477819569 +252.79 13.7862587826848 3.12194535901427 0.797998414506062 +259.57 13.7871585810903 3.12194640230461 0.805663699537849 +258.7 13.7880583797978 3.12194744482169 0.814978932024049 +258.16 13.7889581788072 3.12194848656551 0.813181680000593 +258.12 13.7898579781182 3.12194952753606 0.804250916078639 +255.68 13.7907577777306 3.12195056773335 0.797060203035193 +253.74 13.7916575776442 3.12195160715737 0.785870549829941 +252.51 13.7925573778587 3.12195264580812 0.809694147290746 +250.39 13.7934571783739 3.1219536836856 0.792681750980266 +245.99 13.7943569791896 3.12195472078982 0.801284935161288 +251.47 13.7952567803056 3.12195575712076 0.800587601160019 +259.39 13.7961565817216 3.12195679267842 0.817221132399968 +252.21 13.7970563834374 3.12195782746282 0.824217842777563 +248.25 13.7979561854529 3.12195886147393 0.828689739112028 +240.65 13.7988559877677 3.12195989471177 0.832907786989472 +239.75 13.7997557903816 3.12196092717633 0.829604040812485 +226.27 13.8006555932945 3.12196195886762 0.834268782586398 +228.4 13.7115776920627 3.12095159628785 0.831622617985619 +225.91 13.7124774638475 3.12095270343287 0.829712967181552 +232.89 13.713377235953 3.12095380980496 0.821751407076124 +232.9 13.7142770083789 3.12095491540413 0.810582456363463 +222.25 13.715176781125 3.12095602023036 0.811517596896373 +227.52 13.716076554191 3.12095712428366 0.81840327759938 +233.13 13.7169763275768 3.12095822756403 0.818118032566628 +237.27 13.7178761012822 3.12095933007147 0.820889174076451 +237.81 13.7187758753068 3.12096043180597 0.824193078557168 +235.54 13.7196756496505 3.12096153276753 0.819996755610718 +239.61 13.7205754243131 3.12096263295616 0.821406215881796 +237.07 13.7214751992943 3.12096373237184 0.819023487713719 +243.72 13.7223749745939 3.12096483101459 0.81034226615622 +243.52 13.7232747502117 3.12096592888439 0.818313789141575 +255.81 13.7241745261474 3.12096702598125 0.794619723175595 +244.22 13.7250743024009 3.12096812230517 0.807513306613678 +242.13 13.7259740789719 3.12096921785613 0.811995337906261 +245.35 13.7268738558602 3.12097031263415 0.808318886921098 +251.72 13.7277736330655 3.12097140663922 0.806475324685066 +249.04 13.7286734105877 3.12097249987135 0.809180386676332 +250.28 13.7295731884265 3.12097359233052 0.800516399057534 +247.84 13.7304729665817 3.12097468401673 0.80518220232137 +244.02 13.731372745053 3.12097577492999 0.806617203820038 +240.73 13.7322725238403 3.1209768650703 0.80883310592905 +239.13 13.7331723029434 3.12097795443765 0.80643309130492 +238.78 13.7340720823619 3.12097904303204 0.801500390810711 +237.73 13.7349718620957 3.12098013085347 0.800061706810375 +240.95 13.7358716421445 3.12098121790194 0.808757135642246 +250.42 13.7367714225082 3.12098230417745 0.815132678009364 +245.12 13.7376712031864 3.12098338967999 0.793894094200979 +258.21 13.7385709841791 3.12098447440957 0.78891004474866 +247.59 13.7394707654858 3.12098555836618 0.787977227059612 +244.35 13.7403705471066 3.12098664154983 0.818760263479829 +247.93 13.741270329041 3.12098772396051 0.818036144145439 +253.87 13.7421701112889 3.12098880559821 0.80290869591455 +250.85 13.74306989385 3.12098988646294 0.799973656276392 +254.74 13.7439696767242 3.1209909665547 0.802772695550484 +251.12 13.7448694599112 3.12099204587349 0.802205698811676 +237.38 13.7457692434108 3.1209931244193 0.817534743982711 +247.81 13.7466690272227 3.12099420219213 0.814769493766597 +242.05 13.7475688113468 3.12099527919199 0.815919231641836 +230.59 13.7484685957828 3.12099635541886 0.814945556036008 +229.65 13.7493683805305 3.12099743087275 0.808228873848332 +232.78 13.7502681655896 3.12099850555367 0.805264325621735 +235.57 13.75116795096 3.12099957946159 0.810294578315642 +237.86 13.7520677366414 3.12100065259653 0.814556819181614 +243.37 13.7529675226336 3.12100172495849 0.809887684344174 +234.03 13.7538673089363 3.12100279654746 0.812199598007516 +232.01 13.7547670955494 3.12100386736344 0.820565778179269 +236.95 13.7556668824727 3.12100493740643 0.824353440242148 +231.06 13.7565666697058 3.12100600667642 0.813909759459481 +228.89 13.7574664572486 3.12100707517343 0.814848032689964 +234.42 13.7583662451008 3.12100814289744 0.813618951451331 +247.59 13.7592660332623 3.12100920984845 0.809692384224713 +258.84 13.7601658217328 3.12101027602647 0.80036170212766 +264.44 13.761065610512 3.12101134143149 0.780462312166747 +257.55 13.7619653995998 3.12101240606351 0.80353846811454 +274.76 13.7628651889959 3.12101346992252 0.798251335628188 +250.52 13.7637649787002 3.12101453300854 0.800539635647464 +236.01 13.7646647687123 3.12101559532155 0.812413748964988 +248.47 13.7655645590321 3.12101665686156 0.82143177335485 +219.69 13.7664643496593 3.12101771762856 0.817286314730368 +225.49 13.7673641405937 3.12101877762256 0.827087985707905 +219.06 13.7682639318351 3.12101983684354 0.823527995763324 +242.06 13.7691637233833 3.12102089529152 0.81355684345825 +266.82 13.770063515238 3.12102195296648 0.79752860617736 +263.49 13.770963307399 3.12102300986844 0.791228168697703 +239.94 13.7718630998661 3.12102406599737 0.807479726633326 +241.23 13.7727628926391 3.1210251213533 0.808186844864746 +252.9 13.7736626857177 3.1210261759362 0.807642430061704 +252.65 13.7745624791017 3.12102722974609 0.809699305441158 +259.48 13.775462272791 3.12102828278296 0.800390708416049 +260.55 13.7763620667852 3.12102933504681 0.803492830878011 +242.94 13.7772618610841 3.12103038653763 0.81287613989182 +231.72 13.7781616556876 3.12103143725544 0.821553660669906 +232.79 13.7790614505953 3.12103248720022 0.808668756186077 +255.87 13.7799612458072 3.12103353637197 0.799222303914823 +245.59 13.7808610413229 3.12103458477069 0.801990128960357 +247.5 13.7817608371422 3.12103563239639 0.817230159852879 +254 13.7826606332649 3.12103667924906 0.809540433021331 +238.32 13.7835604296908 3.1210377253287 0.80644221532841 +246.22 13.7844602264196 3.12103877063531 0.788474632223987 +246.4 13.7853600234512 3.12103981516888 0.811034094111017 +244.58 13.7862598207853 3.12104085892942 0.801891596069265 +260.2 13.7871596184217 3.12104190191692 0.793293849796153 +255.59 13.7880594163601 3.12104294413138 0.811274683143809 +262.87 13.7889592146004 3.12104398557281 0.779653512373408 +245.7 13.7898590131422 3.12104502624119 0.810654490106545 +256.83 13.7907588119855 3.12104606613654 0.778228555415675 +259.89 13.7916586111299 3.12104710525884 0.785110037660379 +264.9 13.7925584105753 3.1210481436081 0.791861864855125 +253.43 13.7934582103214 3.12104918118432 0.793859424945251 +253.8 13.7943580103679 3.12105021798748 0.789672638700519 +252.7 13.7952578107148 3.1210512540176 0.81154319336721 +261.97 13.7961576113616 3.12105228927468 0.815233232454732 +255.36 13.7970574123083 3.1210533237587 0.807579144280659 +244.44 13.7979572135546 3.12105435746967 0.815454315158769 +233.56 13.7988570151003 3.12105539040758 0.820004116375825 +234.77 13.7997568169451 3.12105642257245 0.817969326197545 +219.95 13.8006566190888 3.12105745396426 0.824463103946837 +229.36 13.7115787936755 3.12004712210519 0.831130716280393 +228.21 13.7124785646915 3.12004822892874 0.819614711033275 +235.34 13.7133783360282 3.12004933497959 0.806899787662136 +232.42 13.7142781076853 3.12005044025773 0.81296832309898 +231.06 13.7151778796625 3.12005154476317 0.810130137627563 +230.2 13.7160776519598 3.1200526484959 0.808805488297014 +236.4 13.7169774245768 3.12005375145593 0.802948112289768 +237.76 13.7178771975133 3.12005485364324 0.813368791887327 +232.89 13.7187769707692 3.12005595505784 0.80495368538364 +234.49 13.7196767443441 3.12005705569973 0.8173419984501 +239.02 13.7205765182378 3.12005815556891 0.81598651337272 +232.9 13.7214762924502 3.12005925466537 0.826833538867537 +230.73 13.722376066981 3.12006035298912 0.813029485817466 +233.54 13.72327584183 3.12006145054015 0.804690147714028 +244.63 13.7241756169969 3.12006254731845 0.790408064784289 +249.29 13.7250753924816 3.12006364332404 0.790163621467264 +242.85 13.7259751682838 3.12006473855691 0.798945447984121 +241.27 13.7268749444032 3.12006583301705 0.807992318740527 +239.54 13.7277747208398 3.12006692670447 0.811404103617306 +245.41 13.7286744975931 3.12006801961916 0.793424327709903 +246.72 13.7295742746631 3.12006911176113 0.792884775476225 +240.85 13.7304740520495 3.12007020313036 0.801244130513304 +240.71 13.731373829752 3.12007129372687 0.81086877568575 +240.74 13.7322736077705 3.12007238355065 0.797050717202809 +234.5 13.7331733861047 3.12007347260169 0.794309364562707 +247.8 13.7340731647544 3.12007456088 0.792727725296387 +242.82 13.7349729437193 3.12007564838557 0.809119240469678 +242.3 13.7358727229993 3.12007673511841 0.802788618045614 +253.26 13.7367725025942 3.12007782107851 0.801468494331519 +247.72 13.7376722825036 3.12007890626587 0.787306519553676 +259.28 13.7385720627274 3.12007999068049 0.760397393965434 +255.51 13.7394718432653 3.12008107432236 0.813333993864141 +239.14 13.7403716241172 3.1200821571915 0.833321171560911 +255.27 13.7412714052828 3.12008323928788 0.807589496881405 +251.11 13.7421711867618 3.12008432061153 0.805328228322134 +247.74 13.7430709685542 3.12008540116242 0.803412395938409 +256.93 13.7439707506595 3.12008648094057 0.799824455111774 +248 13.7448705330777 3.12008755994597 0.809751483487655 +240.59 13.7457703158084 3.12008863817861 0.822065649747695 +243.65 13.7466700988515 3.1200897156385 0.803516320184616 +246.16 13.7475698822067 3.12009079232564 0.803515835303481 +237.84 13.7484696658738 3.12009186824003 0.805851253556963 +243.9 13.7493694498527 3.12009294338165 0.803560617152535 +239.99 13.750269234143 3.12009401775052 0.809958029182711 +247.4 13.7511690187445 3.12009509134663 0.806837250705506 +251.89 13.752068803657 3.12009616416998 0.810159183748237 +242.17 13.7529685888804 3.12009723622057 0.80597080286159 +242.37 13.7538683744143 3.12009830749839 0.797067252312757 +236.63 13.7547681602585 3.12009937800345 0.8117044341178 +244.12 13.7556679464129 3.12010044773574 0.810627330050168 +235.1 13.7565677328772 3.12010151669527 0.804306336755198 +237.27 13.7574675196511 3.12010258488203 0.812987586380892 +251.7 13.7583673067345 3.12010365229601 0.803372648259448 +244.31 13.7592670941271 3.12010471893723 0.808282663642134 +244.23 13.7601668818287 3.12010578480567 0.807901833664315 +253.97 13.7610666698391 3.12010684990134 0.802598869170385 +250.12 13.761966458158 3.12010791422424 0.804080987029421 +270.4 13.7628662467853 3.12010897777436 0.797622037690355 +252.87 13.7637660357206 3.1201100405517 0.812906194501804 +245.59 13.7646658249639 3.12011110255626 0.813049514113836 +245.81 13.7655656145148 3.12011216378804 0.816232164707945 +228.83 13.7664654043731 3.12011322424704 0.809017374470854 +226.18 13.7673651945387 3.12011428393326 0.816739162346542 +231.97 13.7682649850112 3.12011534284669 0.818824399032909 +241.78 13.7691647757905 3.12011640098734 0.814037502150353 +250.54 13.7700645668763 3.1201174583552 0.801391858731073 +257.48 13.7709643582684 3.12011851495027 0.78611516754154 +254.99 13.7718641499667 3.12011957077255 0.781299744491882 +232.51 13.7727639419707 3.12012062582204 0.805823914504259 +247.68 13.7736637342805 3.12012168009874 0.799733225076843 +252.59 13.7745635268956 3.12012273360265 0.797133077112709 +275.88 13.775463319816 3.12012378633376 0.793415800070333 +268.07 13.7763631130413 3.12012483829207 0.785282124153144 +257.04 13.7772629065713 3.12012588947759 0.790266299357208 +231.88 13.7781627004059 3.12012693989031 0.810692318025833 +237.68 13.7790624945448 3.12012798953023 0.813103930402361 +256.21 13.7799622889877 3.12012903839735 0.784843298537137 +248.36 13.7808620837345 3.12013008649166 0.807974796454802 +242.68 13.7817618787849 3.12013113381317 0.813948471400395 +244.84 13.7826616741387 3.12013218036188 0.816063430577412 +242.04 13.7835614697957 3.12013322613778 0.815729239783929 +238.83 13.7844612657557 3.12013427114087 0.811514390052018 +235.04 13.7853610620184 3.12013531537116 0.811284755209323 +236.72 13.7862608585836 3.12013635882863 0.804503064754314 +256.13 13.787160655451 3.12013740151329 0.80723793153268 +256.11 13.7880604526205 3.12013844342514 0.803516475051515 +260.14 13.7889602500919 3.12013948456418 0.796892233702155 +244.89 13.7898600478649 3.1201405249304 0.813733777162733 +252.33 13.7907598459392 3.1201415645238 0.797463449414299 +259.11 13.7916596443147 3.12014260334438 0.796382810360045 +265.4 13.7925594429912 3.12014364139215 0.797624717010162 +248.81 13.7934592419683 3.1201446786671 0.810608679965725 +250.96 13.794359041246 3.12014571516922 0.806459114778695 +251.18 13.7952588408239 3.12014675089852 0.813083776404656 +247.17 13.7961586407019 3.120147785855 0.805182837749758 +247.46 13.7970584408797 3.12014882003865 0.804168339197028 +242.49 13.797958241357 3.12014985344947 0.805843343638638 +239.19 13.7988580421338 3.12015088608747 0.81678808712446 +244.61 13.7997578432097 3.12015191795263 0.822423105986398 +223.96 13.8006576445845 3.12015294904497 0.811312134130173 +228.96 13.7115798949674 3.11914264790655 0.818606825619448 +228.79 13.7124796652148 3.11914375440864 0.821020119812474 +227.09 13.7133794357829 3.11914486013824 0.819253666552975 +229.37 13.7142792066714 3.11914596509537 0.815920048133649 +231.8 13.7151789778801 3.11914706928001 0.814964414772144 +230.15 13.7160787494088 3.11914817269217 0.817054002039549 +233.12 13.7169785212572 3.11914927533185 0.819212254327366 +234.47 13.7178782934252 3.11915037719904 0.814521157443402 +232.15 13.7187780659125 3.11915147829375 0.823479524185281 +235.25 13.7196778387188 3.11915257861597 0.815289465526497 +239.34 13.720577611844 3.1191536781657 0.818603599331782 +235.28 13.7214773852878 3.11915477694294 0.812243090886191 +231.49 13.72237715905 3.11915587494768 0.816402691889357 +237.38 13.7232769331304 3.11915697217993 0.801497461427527 +240.69 13.7241767075287 3.11915806863969 0.803017224619931 +254.37 13.7250764822448 3.11915916432695 0.785612906366676 +240.38 13.7259762572784 3.11916025924172 0.806935890925613 +248.64 13.7268760326292 3.11916135338398 0.798547492069862 +247.12 13.7277758082972 3.11916244675375 0.805082461900514 +240.7 13.7286755842819 3.11916353935101 0.797233635734917 +245.59 13.7295753605833 3.11916463117578 0.805311221061633 +247.1 13.7304751372011 3.11916572222803 0.807738235584931 +240.68 13.731374914135 3.11916681250779 0.813573198960946 +244.74 13.7322746913849 3.11916790201503 0.79595445475943 +249.76 13.7331744689505 3.11916899074977 0.798404305394295 +255.54 13.7340742468316 3.11917007871199 0.798994783245371 +249.5 13.7349740250279 3.11917116590171 0.802157956265931 +250.1 13.7358738035393 3.11917225231892 0.806360155822701 +252.04 13.7367735823656 3.11917333796361 0.809718444460781 +245.96 13.7376733615064 3.11917442283578 0.790729680930315 +245.97 13.7385731409616 3.11917550693544 0.785284845987432 +246.65 13.7394729207309 3.11917659026258 0.81932362287374 +242.43 13.7403727008142 3.11917767281721 0.827801590434832 +254.56 13.7412724812111 3.11917875459931 0.805788288120851 +247.47 13.7421722619216 3.11917983560889 0.808838651084941 +246.03 13.7430720429453 3.11918091584595 0.801286043596069 +249.19 13.743971824282 3.11918199531048 0.80004696305573 +248.84 13.7448716059315 3.11918307400249 0.819844460790265 +238.79 13.7457713878936 3.11918415192197 0.826394160583942 +246.65 13.7466711701681 3.11918522906892 0.803255037364846 +248.08 13.7475709527547 3.11918630544335 0.79793055138597 +247.03 13.7484707356532 3.11918738104524 0.811724517906336 +239.27 13.7493705188634 3.1191884558746 0.813747325689835 +239.23 13.7502703023851 3.11918952993143 0.804204983162879 +242.79 13.751170086218 3.11919060321572 0.804474038371256 +244.37 13.7520698703619 3.11919167572748 0.820628098446792 +248.76 13.7529696548166 3.1191927474667 0.797084482194834 +243.91 13.7538694395819 3.11919381843338 0.805333385583008 +241.37 13.7547692246575 3.11919488862751 0.807859988817248 +245.21 13.7556690100432 3.11919595804911 0.795470770207028 +242.71 13.7565687957389 3.11919702669817 0.813929345668834 +243.34 13.7574685817442 3.11919809457468 0.804325868409009 +242.44 13.7583683680589 3.11919916167865 0.802071364364716 +242.04 13.7592681546829 3.11920022801006 0.815199575224508 +244.79 13.7601679416158 3.11920129356894 0.805859155378867 +254.46 13.7610677288576 3.11920235835526 0.79741319766501 +252.7 13.7619675164079 3.11920342236903 0.792471694981805 +263.89 13.7628673042665 3.11920448561025 0.801421905903735 +256.15 13.7637670924332 3.11920554807891 0.810184393153874 +239.41 13.7646668809078 3.11920660977502 0.811415726883249 +234.11 13.76556666969 3.11920767069858 0.827937053955348 +222.82 13.7664664587797 3.11920873084958 0.819125172849866 +236.5 13.7673662481766 3.11920979022802 0.811759169614238 +235.07 13.7682660378805 3.1192108488339 0.811743010298967 +232.06 13.7691658278911 3.11921190666721 0.812838521159696 +240.93 13.7700656182083 3.11921296372797 0.815627441069705 +244.74 13.7709654088318 3.11921402001616 0.811572619740159 +250.52 13.7718651997613 3.11921507553179 0.817951459001465 +244.3 13.7727649909968 3.11921613027485 0.810763775000289 +239.54 13.7736647825378 3.11921718424534 0.800345915149049 +245.29 13.7745645743843 3.11921823744327 0.816133010482622 +252.27 13.775464366536 3.11921928986862 0.799268032530125 +244.74 13.7763641589926 3.1192203415214 0.810118042559355 +243.15 13.777263951754 3.11922139240161 0.814659420919263 +226.72 13.7781637448199 3.11922244250925 0.805652402723416 +236.86 13.7790635381901 3.11922349184431 0.812660150675893 +235.95 13.7799633318644 3.11922454040679 0.813511863739293 +231.48 13.7808631258425 3.1192255881967 0.807075946427189 +234.68 13.7817629201243 3.11922663521402 0.822967607880969 +236.77 13.7826627147094 3.11922768145877 0.813143477017909 +242.72 13.7835625095977 3.11922872693093 0.811752201639842 +235.99 13.784462304789 3.11922977163051 0.818210393563151 +231.89 13.785362100283 3.1192308155575 0.815355214222843 +235.74 13.7862618960795 3.11923185871191 0.81449684184706 +240.78 13.7871616921783 3.11923290109374 0.816434550846503 +252.26 13.7880614885791 3.11923394270297 0.803151979842169 +263.73 13.7889612852818 3.11923498353962 0.804239658471956 +255.74 13.7898610822861 3.11923602360367 0.810145057039883 +248.66 13.7907608795918 3.11923706289513 0.812284119928119 +252.33 13.7916606771986 3.119238101414 0.816384548077295 +250.99 13.7925604751064 3.11923913916027 0.817982471958741 +246.73 13.7934602733148 3.11924017613395 0.812805745347893 +246.84 13.7943600718238 3.11924121233503 0.811504529237283 +246.38 13.795259870633 3.11924224776351 0.813873121433663 +246.29 13.7961596697423 3.11924328241939 0.811763805441812 +235.58 13.7970594691514 3.11924431630267 0.798471541788287 +239.16 13.79795926886 3.11924534941335 0.804028846573181 +230.86 13.7988590688681 3.11924638175142 0.815860168429978 +229.64 13.7997588691753 3.11924741331689 0.823557342750731 +235.25 13.8006586697814 3.11924844410976 0.821866242520639 +226.96 13.7115809959384 3.11823817369195 0.817542609418611 +227.94 13.7124807654175 3.11823927987257 0.818109529508094 +229.07 13.7133805352172 3.11824038528093 0.819159055226395 +222.3 13.7142803053374 3.11824148991704 0.815139615004698 +228.71 13.7151800757778 3.11824259378089 0.816619089473643 +233.78 13.7160798465381 3.11824369687248 0.81395961199636 +227.96 13.7169796176182 3.11824479919181 0.822229054342854 +231.41 13.7178793890178 3.11824590073888 0.817691199311364 +233.29 13.7187791607367 3.11824700151369 0.816308491668204 +232.68 13.7196789327746 3.11824810151624 0.816268877792539 +235.88 13.7205787051314 3.11824920074652 0.819917003148801 +239.75 13.7214784778069 3.11825029920454 0.816348191403202 +236.63 13.7223782508007 3.11825139689028 0.822951108113458 +235.34 13.7232780241128 3.11825249380376 0.811521174512823 +233.57 13.7241777977428 3.11825358994497 0.815315332304919 +235.72 13.7250775716905 3.11825468531391 0.80945737717193 +244.55 13.7259773459557 3.11825577991057 0.801408688705911 +239.74 13.7268771205382 3.11825687373496 0.817895955484184 +246.38 13.7277768954378 3.11825796678707 0.814169422061423 +240.85 13.7286766706541 3.11825905906691 0.803426023979788 +238.36 13.7295764461872 3.11826015057447 0.804674549239895 +240.03 13.7304762220365 3.11826124130975 0.804009711018874 +242.99 13.7313759982021 3.11826233127274 0.810194657811469 +246.38 13.7322757746836 3.11826342046346 0.797760696637101 +248.23 13.7331755514808 3.11826450888189 0.800136061219862 +244.25 13.7340753285935 3.11826559652804 0.798837421102232 +251.62 13.7349751060215 3.1182666834019 0.802035558040605 +248.24 13.7358748837645 3.11826776950347 0.810026034454107 +255.05 13.7367746618224 3.11826885483275 0.804918639053254 +245.82 13.7376744401948 3.11826993938974 0.787949661245485 +249.1 13.7385742188816 3.11827102317444 0.799320510460764 +247.62 13.7394739978825 3.11827210618685 0.804119105935271 +248.75 13.7403737771974 3.11827318842696 0.807484721763274 +243.57 13.741273556826 3.11827426989478 0.812631971419984 +248.57 13.742173336768 3.1182753505903 0.813772857026945 +247.6 13.7430731170233 3.11827643051352 0.796075267732892 +259.06 13.7439728975917 3.11827750966444 0.806510647331396 +236.08 13.7448726784728 3.11827858804307 0.816408936358223 +229.94 13.7457724596665 3.11827966564938 0.816394219379294 +250.25 13.7466722411726 3.1182807424834 0.809981178349398 +255.57 13.7475720229908 3.11828181854511 0.809196563921172 +245.48 13.7484718051209 3.11828289383451 0.821269792989294 +236.98 13.7493715875627 3.1182839683516 0.819706546360474 +230.76 13.750271370316 3.11828504209639 0.807973730235214 +232.66 13.7511711533805 3.11828611506887 0.810178041310597 +241.68 13.752070936756 3.11828718726903 0.813501534265258 +240 13.7529707204423 3.11828825869688 0.800696541244744 +241.58 13.7538705044391 3.11828932935242 0.818359238865268 +241.63 13.7547702887464 3.11829039923564 0.802540269837454 +245.84 13.7556700733637 3.11829146834654 0.806046538617768 +246.91 13.7565698582909 3.11829253668513 0.809915687157431 +248.18 13.7574696435278 3.11829360425139 0.817334343833282 +247.05 13.7583694290741 3.11829467104534 0.806093792779755 +253.6 13.7592692149296 3.11829573706696 0.80246286359675 +243.75 13.7601690010942 3.11829680231626 0.807452268124349 +245.86 13.7610687875675 3.11829786679323 0.81726177201172 +250.29 13.7619685743494 3.11829893049788 0.801785179227579 +261.74 13.7628683614396 3.1182999934302 0.804056737376084 +264.93 13.7637681488379 3.11830105559019 0.800628773120913 +233.71 13.764667936544 3.11830211697785 0.819192270531401 +231.42 13.7655677245579 3.11830317759318 0.830273680277632 +226.17 13.7664675128791 3.11830423743618 0.826733085524373 +229.14 13.7673673015076 3.11830529650684 0.818707605783664 +233.3 13.768267090443 3.11830635480517 0.817056406771284 +235.55 13.7691668796852 3.11830741233116 0.809600025737334 +243.53 13.770066669234 3.11830846908481 0.792266856093245 +237.4 13.770966459089 3.11830952506612 0.810796464447429 +241.19 13.7718662492502 3.11831058027509 0.813556596753507 +242.18 13.7727660397171 3.11831163471172 0.805684596096556 +249.69 13.7736658304898 3.11831268837601 0.812438984550983 +249.8 13.7745656215678 3.11831374126795 0.809919724770642 +251.32 13.7754654129511 3.11831479338755 0.801401989792879 +252.64 13.7763652046393 3.1183158447348 0.814200024840546 +238.71 13.7772649966322 3.1183168953097 0.821362180563954 +236.98 13.7781647889297 3.11831794511225 0.823552720068343 +235.75 13.7790645815314 3.11831899414246 0.812861277282496 +233.05 13.7799643744373 3.1183200424003 0.819223814808204 +230.93 13.7808641676469 3.1183210898858 0.811128326828407 +228.98 13.7817639611602 3.11832213659894 0.816641410128711 +232.49 13.7826637549769 3.11832318253972 0.82022226554884 +240.09 13.7835635490968 3.11832422770815 0.821120595316262 +239.72 13.7844633435196 3.11832527210422 0.81837259325324 +233.29 13.7853631382452 3.11832631572793 0.814583173509805 +238.03 13.7862629332732 3.11832735857927 0.803157244906958 +243.03 13.7871627286035 3.11832840065826 0.807363777255449 +245.74 13.7880625242359 3.11832944196488 0.802906358206457 +248.23 13.7889623201701 3.11833048249913 0.796286939615274 +250.28 13.789862116406 3.11833152226102 0.814799260258026 +245.85 13.7907619129432 3.11833256125054 0.810740172316856 +241.97 13.7916617097815 3.11833359946769 0.817537577298648 +245.1 13.7925615069208 3.11833463691247 0.806501669305162 +245.08 13.7934613043608 3.11833567358488 0.822782137709119 +245.59 13.7943611021013 3.11833670948492 0.820475547328404 +252.58 13.7952609001421 3.11833774461258 0.805274133557433 +249.94 13.7961606984829 3.11833877896787 0.805583974384006 +246.58 13.7970604971235 3.11833981255078 0.810597885992087 +241.28 13.7979602960637 3.11834084536131 0.804774560364746 +229.74 13.7988600953033 3.11834187739947 0.817915473590868 +242.63 13.799759894842 3.11834290866524 0.814554517608113 +233.61 13.8006596946796 3.11834393915863 0.822368050152781 +234.61 13.7115820965886 3.11733369946138 0.818367122706383 +226.61 13.7124818652995 3.11733480532053 0.819862653900867 +223.95 13.7133816343312 3.11733591040765 0.818615032687512 +224.28 13.7142814036832 3.11733701472274 0.822403188755114 +234.83 13.7151811733554 3.1173381182658 0.814498547212694 +236.12 13.7160809433476 3.11733922103682 0.799949145770018 +230.4 13.7169807136596 3.11734032303581 0.82422395236834 +229.27 13.717880484291 3.11734142426276 0.821270186595264 +239.7 13.7187802552418 3.11734252471768 0.822220128771382 +236.93 13.7196800265116 3.11734362440055 0.814401412302574 +246.73 13.7205797981003 3.11734472331139 0.805510390117761 +240.43 13.7214795700076 3.11734582145018 0.836006940166045 +241.53 13.7223793422333 3.11734691881693 0.82923043426348 +233.85 13.7232791147772 3.11734801541163 0.822190872954644 +233.52 13.7241788876391 3.11734911123429 0.818007840461081 +233.12 13.7250786608186 3.1173502062849 0.808170279242335 +232.39 13.7259784343157 3.11735130056347 0.816169842167183 +244.19 13.7268782081301 3.11735239406998 0.798668142967524 +243.3 13.7277779822615 3.11735348680444 0.809537341402722 +238.94 13.7286777567097 3.11735457876685 0.797623372753287 +236.31 13.7295775314746 3.11735566995721 0.804592500873099 +230.65 13.7304773065558 3.11735676037551 0.806649144721547 +232.26 13.7313770819532 3.11735785002175 0.80329856410215 +237.12 13.7322768576666 3.11735893889594 0.806789011182396 +244.54 13.7331766336957 3.11736002699806 0.799385787922561 +246.37 13.7340764100402 3.11736111432813 0.799677769983272 +256.02 13.7349761867 3.11736220088613 0.804714147163629 +245.75 13.7358759636749 3.11736328667207 0.798982487496668 +253.51 13.7367757409646 3.11736437168595 0.797371584988695 +250 13.7376755185688 3.11736545592776 0.811887762950068 +248.47 13.7385752964875 3.1173665393975 0.812642103314201 +248.35 13.7394750747203 3.11736762209517 0.803398348228566 +249.57 13.740374853267 3.11736870402078 0.819892482823608 +240.59 13.7412746321274 3.11736978517431 0.80970779054716 +247.32 13.7421744113013 3.11737086555577 0.807565972715782 +245.94 13.7430741907884 3.11737194516515 0.802681821529778 +253.87 13.7439739705886 3.11737302400246 0.802805831428822 +237.69 13.7448737507015 3.1173741020677 0.801349281415574 +237.96 13.7457735311271 3.11737517936085 0.814263498750025 +246.18 13.746673311865 3.11737625588193 0.807844068679656 +253.22 13.747573092915 3.11737733163092 0.809997945883364 +245.82 13.7484728742769 3.11737840660783 0.812848433176167 +242.64 13.7493726559506 3.11737948081266 0.813282038155181 +231.18 13.7502724379356 3.11738055424541 0.807903807615231 +234.17 13.751172220232 3.11738162690607 0.808655135100215 +237.53 13.7520720028393 3.11738269879464 0.810799923343776 +240.49 13.7529717857574 3.11738376991112 0.808191456944846 +243.98 13.7538715689861 3.11738484025552 0.816868272111863 +249.4 13.7547713525251 3.11738590982782 0.802315732184538 +249.15 13.7556711363742 3.11738697862803 0.811536725229544 +250.7 13.7565709205332 3.11738804665614 0.819528114226655 +245.06 13.7574707050019 3.11738911391216 0.806160596360055 +240.68 13.7583704897801 3.11739018039609 0.807777109641211 +244.18 13.7592702748674 3.11739124610791 0.806717737183265 +245.23 13.7601700602638 3.11739231104764 0.809074263701042 +246.29 13.7610698459689 3.11739337521527 0.802261704739094 +250.64 13.7619696319826 3.11739443861079 0.807411834122577 +266.48 13.7628694183046 3.11739550123421 0.813266437850528 +257.2 13.7637692049347 3.11739656308553 0.796689374010498 +240.91 13.7646689918727 3.11739762416474 0.833027950588952 +224.14 13.7655687791183 3.11739868447185 0.832296922348129 +224.48 13.7664685666713 3.11739974400684 0.825512470794056 +232.45 13.7673683545316 3.11740080276973 0.819975524239262 +232.74 13.7682681426988 3.1174018607605 0.813530768564658 +242.99 13.7691679311728 3.11740291797917 0.791157693661087 +249.11 13.7700677199534 3.11740397442572 0.800182453295075 +249.47 13.7709675090402 3.11740503010015 0.790888952784381 +243.11 13.7718672984331 3.11740608500247 0.816843927776404 +247.81 13.7727670881319 3.11740713913267 0.815958347569037 +257.45 13.7736668781363 3.11740819249075 0.793747440057973 +249.03 13.7745666684461 3.11740924507671 0.797235612474119 +252.11 13.7754664590612 3.11741029689055 0.799889454590748 +249.64 13.7763662499811 3.11741134793227 0.807923453763807 +237.15 13.7772660412059 3.11741239820187 0.818713209874236 +240.68 13.7781658327351 3.11741344769934 0.822782600473501 +253.97 13.7790656245687 3.11741449642468 0.799721425772384 +246.63 13.7799654167063 3.11741554437789 0.815364308731464 +237.98 13.7808652091477 3.11741659155898 0.824409243764082 +224.32 13.7817650018928 3.11741763796793 0.820157735565614 +230.22 13.7826647949412 3.11741868360476 0.820441648161855 +234.99 13.7835645882929 3.11741972846945 0.816112441746041 +234.39 13.7844643819475 3.117420772562 0.814932718185313 +238.9 13.7853641759048 3.11742181588242 0.817410831416974 +234.06 13.7862639701646 3.11742285843071 0.81797196777568 +246.54 13.7871637647267 3.11742390020685 0.801057767338478 +249.16 13.7880635595909 3.11742494121086 0.801260148584684 +246.21 13.7889633547568 3.11742598144272 0.803967393261754 +246.96 13.7898631502244 3.11742702090245 0.815209282744052 +245.98 13.7907629459934 3.11742805959003 0.811026040746742 +243.1 13.7916627420635 3.11742909750546 0.816920838578849 +244.96 13.7925625384346 3.11743013464875 0.817148424813251 +241.51 13.7934623351063 3.1174311710199 0.813678758896018 +238.81 13.7943621320786 3.11743220661889 0.81237502554588 +240.75 13.7952619293511 3.11743324144573 0.816668629231067 +249.2 13.7961617269237 3.11743427550043 0.801163099537377 +246.14 13.797061524796 3.11743530878297 0.803618066371151 +239.97 13.797961322968 3.11743634129336 0.812814060378976 +236.85 13.7988611214393 3.11743737303159 0.820040049291436 +232.02 13.7997609202098 3.11743840399767 0.808240643013721 +233.96 13.8006607192792 3.11743943419159 0.801855988286726 +246.85 13.7115831969179 3.11642922521486 0.80555170072875 +232.43 13.7124829648609 3.11643033075254 0.821666997157776 +235.04 13.7133827331247 3.11643143551842 0.81386593377633 +241.71 13.7142825017088 3.11643253951249 0.810917756759566 +239.69 13.7151822706131 3.11643364273476 0.818935009036004 +239.75 13.7160820398374 3.11643474518521 0.801849078456039 +235.36 13.7169818093815 3.11643584686385 0.810148698322417 +234.65 13.717881579245 3.11643694777069 0.814113220093091 +239.15 13.7187813494279 3.11643804790571 0.821817663614664 +244.69 13.7196811199298 3.11643914726891 0.809172683882022 +243.33 13.7205808907506 3.1164402458603 0.819389862597172 +246.37 13.72148066189 3.11644134367987 0.818348617173479 +240.5 13.7223804333478 3.11644244072762 0.822433500459628 +234.18 13.7232802051237 3.11644353700355 0.815256776061702 +241.95 13.7241799772176 3.11644463250766 0.802603856324458 +238.12 13.7250797496293 3.11644572723995 0.81078968542856 +231.99 13.7259795223585 3.11644682120041 0.816226114588423 +237.47 13.7268792954049 3.11644791438905 0.810072541737531 +239.75 13.7277790687684 3.11644900680586 0.81374610038379 +235.94 13.7286788424487 3.11645009845084 0.820920979909154 +234.61 13.7295786164457 3.116451189324 0.824783391953333 +233.44 13.730478390759 3.11645227942532 0.812791781589133 +239.13 13.7313781653884 3.11645336875481 0.830328168169823 +228.28 13.7322779403339 3.11645445731247 0.815578931203931 +240.57 13.733177715595 3.11645554509829 0.812584791078561 +237.78 13.7340774911716 3.11645663211227 0.809774959399892 +243.99 13.7349772670635 3.11645771835442 0.813479017598143 +246.8 13.7358770432704 3.11645880382473 0.802930995293863 +242.79 13.7367768197922 3.1164598885232 0.808910119382944 +242.31 13.7376765966285 3.11646097244983 0.808492008018864 +244.08 13.7385763737792 3.11646205560461 0.816343077212642 +248.3 13.739476151244 3.11646313798755 0.814063452754595 +247.07 13.7403759290228 3.11646421959864 0.80889720435428 +245.26 13.7412757071153 3.11646530043789 0.814080728303138 +244.73 13.7421754855212 3.11646638050529 0.799546273275657 +251.7 13.7430752642404 3.11646745980084 0.804568672071124 +244.77 13.7439750432726 3.11646853832454 0.793027712941196 +235.38 13.7448748226176 3.11646961607639 0.811028130649238 +242.97 13.7457746022752 3.11647069305638 0.812318955176098 +255.31 13.7466743822452 3.11647176926452 0.803355631265398 +241.81 13.7475741625273 3.1164728447008 0.821653058052577 +248 13.7484739431213 3.11647391936522 0.815323663320103 +241.65 13.7493737240269 3.11647499325779 0.817495931568422 +230.1 13.7502735052441 3.11647606637849 0.79595126961632 +240.33 13.7511732867724 3.11647713872734 0.793414527945348 +242.59 13.7520730686118 3.11647821030432 0.810200301693686 +245.07 13.7529728507619 3.11647928110943 0.804769201817351 +246.53 13.7538726332227 3.11648035114268 0.814299461053525 +246.07 13.7547724159937 3.11648142040407 0.794374666329484 +254.05 13.7556721990749 3.11648248889358 0.799326213385355 +260.68 13.7565719824659 3.11648355661123 0.772113022113022 +250.43 13.7574717661667 3.11648462355701 0.810676134774998 +236.75 13.7583715501768 3.11648568973091 0.809160245073269 +247.75 13.7592713344962 3.11648675513294 0.819687987748133 +241.5 13.7601711191246 3.11648781976309 0.813022344329382 +259.2 13.7610709040618 3.11648888362137 0.808095101169847 +270.17 13.7619706893075 3.11648994670778 0.793073199768167 +255.79 13.7628704748615 3.1164910090223 0.802632403144477 +257.33 13.7637702607236 3.11649207056494 0.804625152452774 +260.51 13.7646700468936 3.11649313133571 0.797395590305416 +247.48 13.7655698333713 3.11649419133458 0.824832406218799 +236.37 13.7664696201563 3.11649525056158 0.82166772137927 +222.52 13.7673694072486 3.11649630901669 0.835631223321928 +237.95 13.7682691946479 3.11649736669992 0.817982253443017 +244.96 13.7691689823539 3.11649842361125 0.804034115518351 +241.93 13.7700687703664 3.1164994797507 0.804349525106229 +252.42 13.7709685586853 3.11650053511825 0.791722457539217 +245.41 13.7718683473102 3.11650158971392 0.818442256042972 +258.92 13.772768136241 3.11650264353769 0.795642799528448 +247.32 13.7736679254774 3.11650369658957 0.809150796409033 +241.45 13.7745677150193 3.11650474886955 0.805891382093237 +245.85 13.7754675048663 3.11650580037764 0.810123611629419 +241.83 13.7763672950183 3.11650685111382 0.811802039587538 +237.04 13.777267085475 3.11650790107811 0.816106721648216 +259.29 13.7781668762363 3.1165089502705 0.805128877907634 +251.49 13.7790666673018 3.11650999869098 0.803159155161267 +244.92 13.7799664586714 3.11651104633956 0.81063223846592 +237.71 13.7808662503449 3.11651209321624 0.82271105697463 +218.3 13.7817660423219 3.11651313932101 0.826247732724826 +224.77 13.7826658346024 3.11651418465387 0.812143565080345 +223.48 13.783565627186 3.11651522921483 0.810631337116323 +227.66 13.7844654200726 3.11651627300387 0.816393598215663 +240.12 13.7853652132619 3.11651731602101 0.806040410240875 +238.68 13.7862650067537 3.11651835826623 0.812189517281336 +250.06 13.7871648005478 3.11651939973954 0.809673210735587 +255.49 13.788064594644 3.11652044044093 0.807742430049828 +245.31 13.7889643890419 3.1165214803704 0.815847912852984 +240.98 13.7898641837415 3.11652251952796 0.82517577552232 +237.4 13.7907639787425 3.1165235579136 0.807216095956665 +243.5 13.7916637740446 3.11652459552732 0.804164574582297 +242.72 13.7925635696476 3.11652563236912 0.807186601575255 +243.49 13.7934633655514 3.116526668439 0.809435494110993 +244.77 13.7943631617556 3.11652770373695 0.799898463638331 +242.34 13.7952629582601 3.11652873826298 0.814207650273224 +243.65 13.7961627550646 3.11652977201708 0.803848304816865 +234.3 13.797062552169 3.11653080499925 0.800292458742427 +238.5 13.7979623495729 3.11653183720949 0.79888923299267 +230.57 13.7988621472762 3.1165328686478 0.826581437821683 +228.3 13.7997619452786 3.11653389931419 0.815879636526143 +233.84 13.80066174358 3.11653492920864 0.81442853369406 +246.67 13.7115842969263 3.11552475095238 0.793770668668058 +255.61 13.7124840641017 3.1155258561686 0.792434952049822 +249.91 13.7133838315977 3.11552696061324 0.800721452605414 +244.16 13.7142835994142 3.11552806428629 0.807902615417274 +243.5 13.7151833675508 3.11552916718776 0.814623649552994 +243.54 13.7160831360075 3.11553026931765 0.809238271682241 +234.65 13.7169829047838 3.11553137067595 0.818601253698859 +240.77 13.7178826738797 3.11553247126266 0.819116075906128 +238.63 13.7187824432949 3.11553357107778 0.814584126841873 +250.44 13.7196822130291 3.11553467012132 0.82016514221364 +237.57 13.7205819830822 3.11553576839326 0.81903321789181 +239.55 13.7214817534539 3.11553686589361 0.8200043205876 +228.02 13.722381524144 3.11553796262236 0.826179313840214 +234.15 13.7232812951523 3.11553905857952 0.820136149203777 +241.99 13.7241810664785 3.11554015376508 0.805349235124373 +236.79 13.7250808381225 3.11554124817905 0.812161137549103 +232.83 13.7259806100839 3.11554234182141 0.82644150601176 +231.83 13.7268803823627 3.11554343469217 0.811457908123214 +230.55 13.7277801549585 3.11554452679133 0.812908884042856 +240.61 13.7286799278711 3.11554561811889 0.822058485579685 +235.55 13.7295797011003 3.11554670867484 0.811771187218805 +234.57 13.7304794746459 3.11554779845919 0.818754034861201 +240.88 13.7313792485077 3.11554888747193 0.817805940651717 +232.48 13.7322790226854 3.11554997571305 0.817913149062418 +233.56 13.7331787971788 3.11555106318257 0.806159927725198 +233.4 13.7340785719878 3.11555214988048 0.814131320178191 +234.23 13.7349783471119 3.11555323580677 0.81775895007891 +243.77 13.7358781225511 3.11555432096145 0.801486605190907 +250.67 13.7367778983052 3.11555540534451 0.794286718678219 +244.34 13.7376776743738 3.11555648895596 0.810574897923494 +242.19 13.7385774507568 3.11555757179578 0.819076333553643 +241.14 13.7394772274539 3.11555865386399 0.807065929638019 +243.56 13.740377004465 3.11555973516058 0.801977832982993 +237.1 13.7412767817897 3.11556081568554 0.799785270542725 +244.96 13.7421765594279 3.11556189543888 0.814340174501194 +247.8 13.7430763373794 3.11556297442059 0.811909130986876 +236.57 13.7439761156439 3.11556405263068 0.811741794786163 +241.38 13.7448758942212 3.11556513006914 0.821308389047838 +245.67 13.7457756731111 3.11556620673597 0.808110008594421 +244.5 13.7466754523133 3.11556728263117 0.810298040746652 +243.62 13.7475752318276 3.11556835775474 0.816755418552413 +255.6 13.7484750116539 3.11556943210668 0.804570157830808 +227.85 13.7493747917918 3.11557050568698 0.812503523764266 +227.25 13.7502745722412 3.11557157849564 0.815198463716699 +245.34 13.7511743530019 3.11557265053267 0.799835696681787 +250.37 13.7520741340735 3.11557372179806 0.808783454716469 +247.55 13.7529739154559 3.11557479229181 0.805520635718803 +245.07 13.7538736971489 3.11557586201392 0.809303662901115 +240.21 13.7547734791522 3.11557693096439 0.813020611661701 +250.43 13.7556732614656 3.11557799914321 0.805620959801361 +248.51 13.756573044089 3.11557906655039 0.811597449791343 +250.13 13.7574728270219 3.11558013318592 0.80571313275545 +247.56 13.7583726102644 3.1155811990498 0.815684293419313 +256.66 13.759272393816 3.11558226414204 0.815170809581486 +261.88 13.7601721776767 3.11558332846262 0.817752883690838 +263.71 13.7610719618461 3.11558439201156 0.804316800687496 +255.92 13.761971746324 3.11558545478883 0.800932207937567 +257.33 13.7628715311103 3.11558651679446 0.798986930631815 +265.62 13.7637713162047 3.11558757802843 0.79928926157192 +263.72 13.7646711016069 3.11558863849075 0.797659338684557 +252.31 13.7655708873168 3.1155896981814 0.804922910879124 +238.62 13.7664706733341 3.1155907571004 0.810462666770695 +230.99 13.7673704596586 3.11559181524773 0.81830667956671 +233.05 13.7682702462901 3.11559287262341 0.815073652325577 +240.67 13.7691700332284 3.11559392922742 0.810498578895722 +234.06 13.7700698204732 3.11559498505976 0.806741554486254 +238.11 13.7709696080243 3.11559604012044 0.812191644368054 +264.02 13.7718693958814 3.11559709440945 0.808698067254419 +264.69 13.7727691840445 3.11559814792679 0.779765388840335 +255.51 13.7736689725131 3.11559920067247 0.812479150759468 +249.34 13.7745687612872 3.11560025264647 0.811954285974037 +246.8 13.7754685503665 3.1156013038488 0.811449866307611 +246.62 13.7763683397507 3.11560235427946 0.809014592415378 +241.44 13.7772681294397 3.11560340393844 0.819208315588336 +253.98 13.7781679194331 3.11560445282574 0.805030644471617 +249.24 13.7790677097309 3.11560550094137 0.808014164005871 +232.56 13.7799675003327 3.11560654828532 0.816334628485222 +218.18 13.7808672912384 3.11560759485759 0.818233520103491 +217.53 13.7817670824477 3.11560864065817 0.821515978313056 +225.12 13.7826668739604 3.11560968568708 0.821376683551262 +225.61 13.7835666657762 3.11561072994429 0.819025757144694 +226.65 13.784466457895 3.11561177342983 0.813763943140176 +236.63 13.7853662503166 3.11561281614368 0.806515006906439 +244.01 13.7862660430406 3.11561385808584 0.817022516397974 +243.16 13.7871658360669 3.11561489925631 0.816978780256607 +248.91 13.7880656293953 3.11561593965509 0.811134629201701 +252.96 13.7889654230254 3.11561697928217 0.811932895696572 +238.95 13.7898652169572 3.11561801813757 0.814673490567155 +239.96 13.7907650111904 3.11561905622127 0.799883309022713 +241.36 13.7916648057247 3.11562009353327 0.812751768925075 +239.04 13.79256460056 3.11562113007358 0.814650803798357 +238.43 13.7934643956959 3.11562216584219 0.80990317635565 +241.1 13.7943641911323 3.1156232008391 0.800843402805936 +249.07 13.795263986869 3.11562423506431 0.816128061056076 +236.7 13.7961637829058 3.11562526851782 0.818683215329503 +235.99 13.7970635792423 3.11562630119962 0.802559861822863 +237.24 13.7979633758785 3.11562733310972 0.80442520208531 +239.56 13.798863172814 3.11562836424812 0.801547657210565 +241.67 13.7997629700486 3.1156293946148 0.815312092259775 +237.72 13.8006627675821 3.11563042420978 0.824345079085476 +246.11 13.7115853966139 3.11462027667395 0.798411276083315 +245.28 13.7124851630218 3.11462138156871 0.814957919034724 +239.7 13.7133849297504 3.1146224856921 0.815592209458883 +240.31 13.7142846967994 3.11462358904414 0.813752711984442 +238.95 13.7151844641686 3.11462469162482 0.811751257774134 +241.8 13.7160842318578 3.11462579343414 0.807374536313192 +232.53 13.7169839998667 3.11462689447209 0.809333385099196 +233.93 13.7178837681951 3.11462799473869 0.814690332182539 +240.81 13.7187835368428 3.11462909423392 0.814798895583061 +248.87 13.7196833058096 3.11463019295778 0.804968480677285 +238.38 13.7205830750952 3.11463129091028 0.817380806448617 +229.62 13.7214828446994 3.1146323880914 0.814180138568129 +223.36 13.7223826146221 3.11463348450116 0.821029488965814 +230.74 13.7232823848629 3.11463458013955 0.811096817361728 +239.45 13.7241821554216 3.11463567500656 0.812711895980031 +235.55 13.7250819262981 3.1146367691022 0.82364790195187 +231.69 13.7259816974921 3.11463786242647 0.818363411467337 +233.78 13.7268814690034 3.11463895497936 0.812839964490356 +243.85 13.7277812408317 3.11464004676087 0.819735937782601 +240.87 13.7286810129768 3.114641137771 0.810858866248537 +242.23 13.7295807854386 3.11464222800975 0.803883562891777 +245.62 13.7304805582167 3.11464331747712 0.812931081999743 +237.91 13.731380331311 3.1146444061731 0.80803395530103 +241.89 13.7322801047213 3.1146454940977 0.800694520827768 +237.27 13.7331798784472 3.11464658125092 0.817214755072009 +237.57 13.7340796524886 3.11464766763274 0.806696181959378 +239.83 13.7349794268453 3.11464875324318 0.809122033764905 +249.18 13.7358792015171 3.11464983808223 0.802199342689366 +239.99 13.7367789765036 3.11465092214989 0.815798027955358 +248.41 13.7376787518047 3.11465200544615 0.816581607235771 +237.84 13.7385785274202 3.11465308797102 0.810434958747867 +238.44 13.7394783033499 3.1146541697245 0.815921244071576 +238.18 13.7403780795934 3.11465525070657 0.814100992768722 +236.44 13.7412778561507 3.11465633091725 0.818201362069363 +243.13 13.7421776330214 3.11465741035653 0.81204576473198 +242.74 13.7430774102054 3.11465848902441 0.81149375524262 +241.58 13.7439771877024 3.11465956692089 0.799898844807704 +233.69 13.7448769655122 3.11466064404597 0.808980493191019 +238.28 13.7457767436345 3.11466172039964 0.813402432219649 +249.1 13.7466765220693 3.1146627959819 0.808954725261376 +253.86 13.7475763008161 3.11466387079276 0.801974073579106 +249.08 13.7484760798749 3.1146649448322 0.80380589120717 +228.19 13.7493758592453 3.11466601810024 0.810385819250855 +239.39 13.7502756389272 3.11466709059687 0.801661710099635 +244.27 13.7511754189203 3.11466816232208 0.810485233429132 +245.99 13.7520751992244 3.11466923327588 0.812512073086203 +242.65 13.7529749798393 3.11467030345826 0.824574059536186 +242.59 13.7538747607648 3.11467137286923 0.8137915824297 +236.84 13.7547745420006 3.11467244150878 0.81951453616983 +240.88 13.7556743235465 3.11467350937691 0.814821089088411 +247.29 13.7565741054023 3.11467457647362 0.812304824936764 +245.65 13.7574738875678 3.11467564279891 0.817950063732474 +249.95 13.7583736700427 3.11467670835277 0.811216348085644 +250.63 13.7592734528268 3.11467777313521 0.809133943814993 +265.68 13.7601732359199 3.11467883714623 0.809959007135795 +259.15 13.7610730193218 3.11467990038581 0.813311061154057 +264.01 13.7619728030322 3.11468096285397 0.806317496590616 +249.56 13.762872587051 3.1146820245507 0.799975421111679 +258.48 13.7637723713778 3.114683085476 0.813050449308326 +259.18 13.7646721560126 3.11468414562987 0.79976904422803 +246.55 13.7655719409549 3.1146852050123 0.821660430342551 +236.57 13.7664717262047 3.11468626362329 0.828043648552639 +229.7 13.7673715117617 3.11468732146285 0.817445899620708 +233.58 13.7682712976257 3.11468837853098 0.818040236631373 +227.61 13.7691710837964 3.11468943482766 0.811664754832617 +229.16 13.7700708702736 3.11469049035291 0.814724697465315 +238.54 13.7709706570572 3.11469154510671 0.817225769007545 +273.14 13.7718704441468 3.11469259908907 0.818853138930289 +266.33 13.7727702315423 3.11469365229998 0.786270177146923 +245.37 13.7736700192434 3.11469470473945 0.81070555689845 +242.75 13.77456980725 3.11469575640747 0.817948872998836 +242.5 13.7754695955617 3.11469680730405 0.807483681886401 +244.9 13.7763693841784 3.11469785742918 0.813271964139567 +252.51 13.7772691730998 3.11469890678285 0.810739586494829 +254.63 13.7781689623257 3.11469995536507 0.807751541007557 +252.34 13.7790687518559 3.11470100317584 0.805577006889064 +239.54 13.7799685416902 3.11470205021516 0.800365291508422 +236.21 13.7808683318283 3.11470309648302 0.801180412329113 +224.62 13.7817681222701 3.11470414197942 0.821763783794245 +223.32 13.7826679130152 3.11470518670437 0.815328124128812 +222.53 13.7835677040635 3.11470623065785 0.827601638349515 +230.83 13.7844674954147 3.11470727383988 0.81244787322769 +239.21 13.7853672870687 3.11470831625044 0.806605165325833 +245.21 13.7862670790252 3.11470935788954 0.824512965419556 +248.28 13.7871668712839 3.11471039875717 0.806295268916628 +249.17 13.7880666638447 3.11471143885334 0.817160849409085 +244.71 13.7889664567073 3.11471247817804 0.813114804769301 +239.63 13.7898662498716 3.11471351673127 0.806298229641674 +241.34 13.7907660433371 3.11471455451303 0.798499197331906 +240.43 13.7916658371039 3.11471559152332 0.793628089533686 +240.05 13.7925656311716 3.11471662776214 0.801327256736228 +235.17 13.79346542554 3.11471766322948 0.822326990308952 +242.28 13.7943652202088 3.11471869792535 0.795817225063991 +241.89 13.795265015178 3.11471973184974 0.807397693766416 +241.51 13.7961648104471 3.11472076500266 0.806992386490576 +229.84 13.7970646060161 3.11472179738409 0.813900752409875 +230.89 13.7979644018846 3.11472282899405 0.809189778170679 +237.94 13.7988641980526 3.11472385983253 0.815920775261985 +247.84 13.7997639945196 3.11472488989952 0.812944555221571 +251.17 13.8006637912856 3.11472591919503 0.803142596256278 +241.1 13.7115864959806 3.11371580237958 0.806386708330158 +235.25 13.7124862616213 3.11371690695287 0.823666183954043 +236.29 13.7133860275827 3.11371801075502 0.815667064586507 +243.74 13.7142857938644 3.11371911378604 0.816443622703528 +237.93 13.7151855604664 3.11372021604593 0.819465013804326 +234.74 13.7160853273883 3.11372131753468 0.810141602099672 +229.75 13.71698509463 3.1137224182523 0.809919093401688 +238.49 13.7178848621912 3.11372351819877 0.811293987338171 +239.93 13.7187846300716 3.11372461737411 0.815356785693276 +246.42 13.7196843982712 3.1137257157783 0.821078140987668 +236.49 13.7205841667895 3.11372681341135 0.825632334142453 +224.51 13.7214839356265 3.11372791027326 0.814770139114839 +229.18 13.7223837047819 3.11372900636402 0.819076288215322 +237.39 13.7232834742555 3.11373010168364 0.818540244962931 +236.6 13.724183244047 3.11373119623211 0.8198502812763 +236.2 13.7250830141563 3.11373229000942 0.811114489947534 +232.22 13.725982784583 3.11373338301559 0.812752647728398 +234.09 13.726882555327 3.1137344752506 0.807265662866623 +237.15 13.7277823263881 3.11373556671447 0.823478551004374 +246.45 13.728682097766 3.11373665740717 0.801817827189389 +245.55 13.7295818694605 3.11373774732872 0.809380490300007 +251.58 13.7304816414714 3.11373883647911 0.808045430197146 +238.8 13.7313814137984 3.11373992485835 0.807274890119652 +238.86 13.7322811864414 3.11374101246642 0.802731398930135 +248.3 13.7331809594001 3.11374209930333 0.812173521355972 +242.06 13.7340807326743 3.11374318536908 0.809729876948566 +241.21 13.7349805062637 3.11374427066366 0.820283376101998 +256.56 13.7358802801682 3.11374535518708 0.793138416045455 +240.27 13.7367800543874 3.11374643893933 0.814203037424045 +239.71 13.7376798289213 3.11374752192042 0.803665305766171 +245 13.7385796037695 3.11374860413033 0.798933111198328 +239.09 13.7394793789319 3.11374968556907 0.81038935894209 +241.35 13.7403791544082 3.11375076623664 0.801235780807236 +239.67 13.7412789301982 3.11375184613304 0.818880485234018 +247.1 13.7421787063016 3.11375292525826 0.81210441556496 +240.05 13.7430784827183 3.11375400361231 0.816143463926548 +237.66 13.7439782594481 3.11375508119518 0.806907098872822 +232.34 13.7448780364906 3.11375615800687 0.814443715473635 +239.96 13.7457778138457 3.11375723404737 0.807885749767153 +253.19 13.7466775915131 3.1137583093167 0.802719103309464 +252.73 13.7475773694927 3.11375938381484 0.802816684682882 +246.06 13.7484771477842 3.11376045754181 0.800038493414877 +231.63 13.7493769263873 3.11376153049758 0.800249592502038 +237.42 13.7502767053019 3.11376260268217 0.801915082828366 +242.77 13.7511764845277 3.11376367409557 0.81308667769805 +240.18 13.7520762640646 3.11376474473778 0.817289267523237 +248.83 13.7529760439122 3.11376581460879 0.809232840143835 +245.01 13.7538758240704 3.11376688370862 0.810678190933382 +244.87 13.7547756045389 3.11376795203725 0.812171898193404 +247.29 13.7556753853175 3.11376901959469 0.814160099102454 +250.22 13.756575166406 3.11377008638093 0.813466186328606 +253.6 13.7574749478042 3.11377115239598 0.797632995566815 +246.24 13.7583747295118 3.11377221763982 0.812586373085276 +248.98 13.7592745115286 3.11377328211247 0.803444522696716 +255.15 13.7601742938544 3.11377434581392 0.804025340052766 +254.58 13.761074076489 3.11377540874416 0.804534162705632 +263.47 13.7619738594322 3.1137764709032 0.798509860081667 +252.08 13.7628736426836 3.11377753229103 0.816148973807848 +244.31 13.7637734262431 3.11377859290765 0.812209329637807 +255.03 13.7646732101106 3.11377965275307 0.820921187907259 +244.61 13.7655729942856 3.11378071182728 0.822929833919086 +235.12 13.7664727787681 3.11378177013028 0.825370146265669 +236.73 13.7673725635578 3.11378282766206 0.81752398930313 +237.68 13.7682723486544 3.11378388442264 0.813171489240326 +237.51 13.7691721340578 3.113784940412 0.819307235404549 +250.6 13.7700719197678 3.11378599563014 0.807690197584469 +243.95 13.770971705784 3.11378705007706 0.820073494263862 +262.32 13.7718714921063 3.11378810375277 0.823027061086868 +258.94 13.7727712787345 3.11378915665726 0.795683431641827 +242.62 13.7736710656683 3.11379020879053 0.81697869593286 +242.68 13.7745708529075 3.11379126015257 0.824426973266142 +238.87 13.7754706404519 3.11379231074339 0.808789125766319 +248.76 13.7763704283013 3.11379336056299 0.805924310326889 +258.09 13.7772702164554 3.11379440961136 0.796041195058447 +260.05 13.778170004914 3.1137954578885 0.807215781797405 +245.4 13.7790697936769 3.11379650539441 0.815165533364097 +239.4 13.7799695827438 3.1137975521291 0.817624131249579 +233.12 13.7808693721146 3.11379859809255 0.822450903840771 +239.74 13.781769161789 3.11379964328477 0.821576364872454 +240.96 13.7826689517668 3.11380068770575 0.796300013650123 +225.41 13.7835687420478 3.11380173135551 0.813769224836723 +229.33 13.7844685326317 3.11380277423402 0.817528551263955 +239.09 13.7853683235184 3.1138038163413 0.822551979219397 +243.51 13.7862681147075 3.11380485767733 0.812735042090904 +257.57 13.7871679061989 3.11380589824213 0.812619280445823 +250.78 13.7880676979923 3.11380693803569 0.800956671893297 +241.49 13.7889674900876 3.113807977058 0.808971017311807 +246.63 13.7898672824845 3.11380901530907 0.788290499446723 +237.88 13.7907670751828 3.11381005278889 0.796064756335444 +232 13.7916668681822 3.11381108949747 0.8008700827333 +231.96 13.7925666614825 3.11381212543479 0.805284150447939 +241.42 13.7934664550835 3.11381316060087 0.812366721413777 +244.03 13.7943662489851 3.1138141949957 0.786424839228296 +242.18 13.7952660431868 3.11381522861928 0.817634979259762 +236.75 13.7961658376887 3.1138162614716 0.802631900192876 +230.95 13.7970656324903 3.11381729355267 0.80537642859211 +234.09 13.7979654275915 3.11381832486248 0.81737202382104 +233.41 13.798865222992 3.11381935540104 0.812477947072975 +242.43 13.7997650186917 3.11382038516834 0.807152393215733 +239.77 13.8006648146904 3.11382141416438 0.813896201302999 +237.77 13.7115875950264 3.11281132806927 0.809562498083821 +235.48 13.7124873599001 3.11281243232109 0.808902697160945 +235.7 13.7133871250945 3.112813535802 0.813260400129414 +237.56 13.7142868906093 3.11281463851201 0.817086453880997 +237.31 13.7151866564442 3.11281574045111 0.817809523459413 +233.13 13.7160864225991 3.11281684161929 0.808330625458834 +235.51 13.7169861890738 3.11281794201656 0.81312054577572 +236.18 13.717885955868 3.11281904164292 0.814347782381915 +245.97 13.7187857229814 3.11282014049837 0.808850460493503 +233.52 13.7196854904139 3.11282123858289 0.820709940504044 +235.49 13.7205852581653 3.1128223358965 0.820311821173164 +227.41 13.7214850262353 3.11282343243918 0.816669749721541 +234.14 13.7223847946237 3.11282452821095 0.814966714665903 +235.59 13.7232845633302 3.1128256232118 0.812363151474744 +239.09 13.7241843323547 3.11282671744172 0.81112616623437 +236.34 13.7250841016969 3.11282781090071 0.806702368642346 +232.38 13.7259838713567 3.11282890358878 0.810743798405445 +228.57 13.7268836413336 3.11282999550592 0.821131904959144 +236.98 13.7277834116277 3.11283108665213 0.807347009244581 +237.36 13.7286831822386 3.11283217702741 0.803970403913799 +247.14 13.729582953166 3.11283326663176 0.813922878879921 +263.24 13.7304827244099 3.11283435546518 0.817911796561966 +247.32 13.7313824959699 3.11283544352766 0.817090065968459 +249.5 13.7322822678458 3.11283653081921 0.816141259530389 +246.63 13.7331820400375 3.11283761733982 0.81607922292743 +247.82 13.7340818125446 3.11283870308949 0.812936938689249 +251.98 13.734981585367 3.11283978806822 0.825379590969965 +259.93 13.7358813585044 3.11284087227601 0.796298396425412 +251.88 13.7367811319567 3.11284195571285 0.812052185942939 +238.3 13.7376809057235 3.11284303837876 0.80743154839784 +241.08 13.7385806798047 3.11284412027372 0.803536863278802 +248.64 13.7394804542 3.11284520139773 0.809810170534954 +239.93 13.7403802289093 3.11284628175079 0.812880248726275 +237.25 13.7412800039322 3.1128473613329 0.814463234535738 +241.85 13.7421797792686 3.11284844014407 0.803525211263214 +247.73 13.7430795549183 3.11284951818428 0.806054083550597 +237.36 13.7439793308809 3.11285059545354 0.815200761179829 +231.33 13.7448791071564 3.11285167195184 0.81698773744058 +237.22 13.7457788837444 3.11285274767919 0.809491423249775 +236.17 13.7466786606448 3.11285382263558 0.817365730533322 +244.31 13.7475784378573 3.11285489682102 0.799825233055248 +240.84 13.7484782153818 3.11285597023549 0.813945523959262 +234.07 13.7493779932178 3.112857042879 0.789722455166352 +248.76 13.7502777713654 3.11285811475155 0.802377135707863 +255.71 13.7511775498242 3.11285918585313 0.804484830719625 +245.12 13.7520773285939 3.11286025618376 0.808956968410692 +239.29 13.7529771076745 3.11286132574341 0.815239077316237 +242.5 13.7538768870656 3.1128623945321 0.806393855867317 +247.29 13.7547766667671 3.11286346254981 0.800004399052737 +242.13 13.7556764467786 3.11286452979656 0.816636095867995 +258.18 13.7565762271001 3.11286559627233 0.789667093779465 +253.91 13.7574760077312 3.11286666197714 0.804059782753337 +248.81 13.7583757886717 3.11286772691096 0.813101862269123 +251.1 13.7592755699215 3.11286879107382 0.805381416423562 +254.82 13.7601753514802 3.11286985446569 0.819398699280492 +252.31 13.7610751333477 3.11287091708659 0.805343723025998 +259.83 13.7619749155238 3.11287197893651 0.806776830148468 +252.23 13.7628746980081 3.11287304001544 0.814820373886483 +255.6 13.7637744808006 3.1128741003234 0.817494950686264 +252.99 13.7646742639009 3.11287515986037 0.809606847845453 +250.21 13.7655740473089 3.11287621862635 0.818847434129294 +237.61 13.7664738310243 3.11287727662135 0.82599639089696 +235.89 13.7673736150469 3.11287833384536 0.827364816664289 +239.08 13.7682733993765 3.11287939029839 0.810373825844123 +238.98 13.7691731840128 3.11288044598042 0.803816717622844 +243.41 13.7700729689556 3.11288150089147 0.803380281690141 +243.51 13.7709727542048 3.11288255503151 0.81195352362497 +242.16 13.77187253976 3.11288360840057 0.814596848580947 +250.16 13.7727723256211 3.11288466099863 0.82950685492122 +240.26 13.7736721117878 3.1128857128257 0.817969286517921 +234.07 13.7745718982599 3.11288676388176 0.82400732775312 +232.63 13.7754716850372 3.11288781416683 0.820621276562628 +246.51 13.7763714721195 3.1128888636809 0.814316396569592 +253.14 13.7772712595065 3.11288991242396 0.812107140834702 +254.54 13.778171047198 3.11289096039602 0.796147962563689 +244.59 13.7790708351938 3.11289200759708 0.80517938332154 +244.35 13.7799706234936 3.11289305402713 0.802918921077325 +240.69 13.7808704120973 3.11289409968618 0.813709435353033 +240 13.7817702010046 3.11289514457422 0.808863068190752 +234.33 13.7826699902153 3.11289618869124 0.803837534555805 +226.77 13.7835697797292 3.11289723203726 0.811121436300954 +244.81 13.784469569546 3.11289827461226 0.809664502288439 +237.78 13.7853693596655 3.11289931641626 0.807654298448582 +252.87 13.7862691500875 3.11290035744923 0.806817412752006 +254.72 13.7871689408118 3.11290139771119 0.813204590630123 +244.17 13.7880687318382 3.11290243720214 0.801717482451035 +234.56 13.7889685231663 3.11290347592206 0.810747746294321 +233.23 13.7898683147961 3.11290451387097 0.810899765931441 +224.27 13.7907681067272 3.11290555104886 0.812621430255339 +234.77 13.7916678989595 3.11290658745572 0.808028895112016 +236.91 13.7925676914927 3.11290762309156 0.819007643637659 +243.37 13.7934674843266 3.11290865795637 0.812278050913107 +240.83 13.794367277461 3.11290969205016 0.815408315838758 +237.13 13.7952670708957 3.11291072537292 0.808556317335945 +234.21 13.7961668646304 3.11291175792465 0.81551672380832 +225.11 13.7970666586649 3.11291278970535 0.818138960691328 +236.18 13.7979664529989 3.11291382071502 0.819526124991041 +235.12 13.7988662476324 3.11291485095366 0.805609112640527 +241.36 13.799766042565 3.11291588042127 0.816855011780949 +231.52 13.8006658377964 3.11291690911784 0.828250602338621 +235.21 13.7115886937514 3.11190685374302 0.80839344418316 +236.82 13.7124884578584 3.11190795767337 0.812908084497496 +235.31 13.7133882222859 3.11190906083305 0.806171357714595 +238.33 13.7142879870339 3.11191016322204 0.815272399142761 +231.63 13.7151877521021 3.11191126484035 0.823033718532471 +239.85 13.7160875174902 3.11191236568797 0.812941212038759 +232.15 13.7169872831981 3.1119134657649 0.815187495048048 +247.1 13.7178870492255 3.11191456507114 0.805790983621497 +239.98 13.7187868155721 3.11191566360669 0.813764244348963 +237.37 13.7196865822379 3.11191676137155 0.817623710753482 +236.84 13.7205863492224 3.11191785836571 0.811514035607846 +229.55 13.7214861165256 3.11191895458918 0.81301538905416 +237.53 13.7223858841472 3.11192005004195 0.822343895619758 +227.29 13.723285652087 3.11192114472402 0.815458885454601 +231.36 13.7241854203447 3.1119222386354 0.815941940131508 +238.14 13.7250851889201 3.11192333177607 0.807974551125249 +237.9 13.725984957813 3.11192442414604 0.810579043367 +236.1 13.7268847270232 3.11192551574531 0.814190898082435 +239.12 13.7277844965504 3.11192660657387 0.815132560868624 +242.76 13.7286842663945 3.11192769663173 0.811220630158937 +258.43 13.7295840365552 3.11192878591888 0.799482587943489 +270.56 13.7304838070322 3.11192987443532 0.798634932238655 +265.75 13.7313835778254 3.11193096218105 0.834471944657955 +259.26 13.7322833489346 3.11193204915607 0.838348857695533 +246.91 13.7331831203594 3.11193313536038 0.821583171077321 +251.96 13.7340828920997 3.11193422079397 0.825894552257869 +249.96 13.7349826641553 3.11193530545685 0.814559838101371 +254.57 13.7358824365259 3.11193638934901 0.810649209978228 +242.49 13.7367822092113 3.11193747247045 0.816167879931698 +244.52 13.7376819822113 3.11193855482118 0.815890729352519 +253.74 13.7385817555257 3.11193963640118 0.815877478859139 +239.6 13.7394815291542 3.11194071721046 0.812276001388353 +242.09 13.7403813030966 3.11194179724902 0.80216433954875 +240.37 13.7412810773528 3.11194287651685 0.817995308457599 +238.94 13.7421808519223 3.11194395501396 0.813726510552183 +242.53 13.7430806268052 3.11194503274033 0.806264368495976 +234.66 13.743980402001 3.11194610969598 0.815882271061138 +230.61 13.7448801775097 3.1119471858809 0.815098442224215 +237.91 13.7457799533309 3.11194826129509 0.812418170377579 +239.55 13.7466797294644 3.11194933593855 0.812564648615759 +241.76 13.7475795059101 3.11195040981127 0.823527309122105 +245.52 13.7484792826677 3.11195148291326 0.80381642175639 +242.73 13.7493790597369 3.11195255524451 0.795384208000265 +247.1 13.7502788371176 3.11195362680502 0.801212158837817 +251.21 13.7511786148096 3.11195469759479 0.811226978025131 +246.53 13.7520783928125 3.11195576761382 0.809643365343783 +251.21 13.7529781711262 3.11195683686211 0.812414348762845 +235.07 13.7538779497505 3.11195790533966 0.812075973351262 +243.07 13.7547777286851 3.11195897304646 0.806097338680277 +249.95 13.7556775079298 3.11196003998252 0.79917086192905 +253.46 13.7565772874844 3.11196110614782 0.797458229302974 +250.74 13.7574770673487 3.11196217154238 0.806790440826431 +237.78 13.7583768475224 3.11196323616619 0.809718245770868 +247.31 13.7592766280053 3.11196430001925 0.807448822154003 +251.05 13.7601764087972 3.11196536310156 0.805512438972204 +248.25 13.7610761898978 3.11196642541311 0.808736881935489 +243.76 13.761975971307 3.11196748695391 0.801010134908383 +243.62 13.7628757530245 3.11196854772395 0.808351528820852 +256.31 13.7637755350502 3.11196960772323 0.798918970937319 +247.38 13.7646753173836 3.11197066695176 0.805799045201258 +244.51 13.7655751000247 3.11197172540952 0.811937019406811 +240.72 13.7664748829733 3.11197278309652 0.803566248751088 +233.48 13.767374666229 3.11197384001276 0.825479018683221 +242.74 13.7682744497917 3.11197489615824 0.815799575793062 +245.12 13.7691742336612 3.11197595153295 0.810663619693811 +243.99 13.7700740178372 3.11197700613689 0.816531309297913 +241.46 13.7709738023195 3.11197805997006 0.807291624702897 +228 13.7718735871078 3.11197911303247 0.813891572035033 +240.31 13.772773372202 3.1119801653241 0.821280585657873 +239.04 13.7736731576019 3.11198121684496 0.831941574037871 +240.88 13.7745729433071 3.11198226759505 0.812352228821867 +242.01 13.7754727293175 3.11198331757437 0.823611285916296 +248.83 13.7763725156329 3.1119843667829 0.813608952693323 +253.98 13.777272302253 3.11198541522067 0.813547969203139 +251.51 13.7781720891777 3.11198646288765 0.804279170119291 +242.54 13.7790718764066 3.11198750978385 0.80704571548061 +250.77 13.7799716639396 3.11198855590927 0.802924499205213 +246.05 13.7808714517764 3.11198960126391 0.811306251483649 +229.95 13.7817712399168 3.11199064584776 0.806563346507394 +232.54 13.7826710283606 3.11199168966083 0.807122369037876 +238.53 13.7835708171076 3.11199273270312 0.807644997330981 +240.36 13.7844706061575 3.11199377497461 0.805518079323376 +242.42 13.7853703955102 3.11199481647532 0.811427662427185 +250.37 13.7862701851653 3.11199585720524 0.802061822855119 +249.48 13.7871699751227 3.11199689716437 0.811097874956769 +238.35 13.7880697653821 3.1119979363527 0.817642938380772 +234.9 13.7889695559434 3.11199897477024 0.810206498466751 +234.68 13.7898693468063 3.11200001241698 0.801792520032035 +242.98 13.7907691379705 3.11200104929293 0.79674927772646 +237.55 13.7916689294359 3.11200208539808 0.809453028634576 +237.25 13.7925687212022 3.11200312073243 0.805972141871746 +251.77 13.7934685132693 3.11200415529598 0.809869235961223 +239.87 13.7943683056368 3.11200518908873 0.816950899375273 +239.52 13.7952680983045 3.11200622211067 0.81327729879052 +235.2 13.7961678912723 3.11200725436181 0.825565246375201 +225.01 13.7970676845399 3.11200828584215 0.822582504130009 +232.87 13.7979674781071 3.11200931655168 0.810281793126723 +232.55 13.7988672719736 3.1120103464904 0.811764332876245 +239.2 13.7997670661392 3.11201137565831 0.806295156800605 +227.46 13.8006668606038 3.11201240405541 0.819628426855977 +233.9 13.7115897921555 3.11100237940083 0.804546476520845 +241.26 13.7124895554959 3.11100348300973 0.806286055767556 +227.05 13.713389319157 3.11100458584817 0.820734867777057 +232.42 13.7142890831384 3.11100568791615 0.819070757745876 +241.46 13.71518884744 3.11100678921366 0.807300539257728 +235.62 13.7160886120616 3.11100788974071 0.810723421433645 +230.63 13.7169883770029 3.1110089894973 0.814061587542965 +231.65 13.7178881422637 3.11101008848343 0.815186487312748 +232.83 13.7187879078438 3.11101118669909 0.817344179556899 +236.8 13.719687673743 3.11101228414428 0.826126729850762 +232.55 13.720587439961 3.11101338081899 0.813056852775697 +234.94 13.7214872064976 3.11101447672324 0.816376295932765 +236.8 13.7223869733526 3.11101557185702 0.825373461977234 +240.97 13.7232867405258 3.11101666622032 0.81708243870406 +233.47 13.7241865080169 3.11101775981315 0.807451046709639 +243.72 13.7250862758258 3.1110188526355 0.790109678351774 +231.35 13.7259860439521 3.11101994468738 0.813890467921414 +246.04 13.7268858123957 3.11102103596877 0.820600745642515 +238.92 13.7277855811564 3.11102212647969 0.820474733370963 +238.29 13.7286853502339 3.11102321622012 0.807965616492851 +251.15 13.729585119628 3.11102430519008 0.802783341648113 +247.42 13.7304848893384 3.11102539338954 0.809785596481583 +263.45 13.731384659365 3.11102648081852 0.818655274132845 +261.76 13.7322844297076 3.11102756747702 0.821556983122704 +252.98 13.7331842003658 3.11102865336502 0.815051148871272 +250.25 13.7340839713396 3.11102973848254 0.796407185628743 +244.55 13.7349837426286 3.11103082282956 0.815542329539026 +248.74 13.7358835142326 3.1110319064061 0.817204455520206 +242.84 13.7367832861514 3.11103298921214 0.812265416305046 +245.1 13.7376830583848 3.11103407124768 0.80755425772992 +248.04 13.7385828309326 3.11103515251273 0.819521917962587 +244.41 13.7394826037945 3.11103623300728 0.817858096028488 +238.96 13.7403823769703 3.11103731273133 0.812074520455581 +238.11 13.7412821504599 3.11103839168488 0.808077140321149 +235.75 13.7421819242628 3.11103946986793 0.797797566272182 +240.13 13.7430816983791 3.11104054728047 0.798265857839905 +233.68 13.7439814728083 3.11104162392252 0.805353378020162 +234.24 13.7448812475503 3.11104269979405 0.810617850829964 +237.53 13.7457810226049 3.11104377489508 0.814500898244968 +236.46 13.7466807979719 3.1110448492256 0.815680975911056 +242.11 13.747580573651 3.11104592278561 0.820242167642125 +244.1 13.7484803496419 3.11104699557511 0.807173614725784 +242.84 13.7493801259446 3.1110480675941 0.800307902424833 +231.67 13.7502799025587 3.11104913884258 0.812970691602862 +234.32 13.751179679484 3.11105020932054 0.809267556248174 +237.98 13.7520794567203 3.11105127902798 0.826949144577747 +233.55 13.7529792342674 3.11105234796491 0.81844283387055 +228.11 13.7538790121251 3.11105341613131 0.811927283476204 +234.76 13.7547787902931 3.1110544835272 0.812667900894158 +246.73 13.7556785687712 3.11105555015256 0.799131850244167 +243.94 13.7565783475591 3.11105661600741 0.809553306645812 +241.63 13.7574781266568 3.11105768109173 0.803892847191816 +243.69 13.7583779060638 3.11105874540552 0.811654599213093 +246.94 13.7592776857801 3.11105980894878 0.802888953338489 +252.71 13.7601774658054 3.11106087172152 0.800634528322065 +243.41 13.7610772461394 3.11106193372373 0.806173586732841 +236.34 13.761977026782 3.11106299495541 0.812591496403794 +245.38 13.7628768077329 3.11106405541655 0.805746596354741 +245.24 13.7637765889918 3.11106511510717 0.803057450480809 +233.64 13.7646763705587 3.11106617402725 0.809188185318923 +233.23 13.7655761524332 3.11106723217679 0.822457855467594 +239.87 13.7664759346151 3.11106828955579 0.810061933721734 +239.11 13.7673757171042 3.11106934616426 0.812043550692026 +243.45 13.7682754999003 3.11107040200219 0.81132887207988 +246.42 13.7691752830031 3.11107145706957 0.811440628479332 +243.75 13.7700750664124 3.11107251136641 0.816464339336507 +228.34 13.7709748501281 3.11107356489271 0.808067841118642 +230.05 13.7718746341498 3.11107461764847 0.818814920662338 +238.5 13.7727744184773 3.11107566963368 0.809772262567863 +243.19 13.7736742031105 3.11107672084834 0.833057569118123 +242.82 13.7745739880491 3.11107777129245 0.819141611200367 +237.55 13.7754737732929 3.11107882096601 0.814192008610671 +241.81 13.7763735588416 3.11107986986902 0.805106709755863 +259.06 13.7772733446951 3.11108091800148 0.80682700063843 +254.66 13.7781731308531 3.11108196536338 0.801300201249213 +241.14 13.7790729173154 3.11108301195473 0.811683907400015 +243.05 13.7799727040817 3.11108405777552 0.809902656390445 +252.02 13.7808724911518 3.11108510282575 0.802824964411249 +230.68 13.7817722785256 3.11108614710542 0.814577574528398 +224.65 13.7826720662028 3.11108719061454 0.808973903036454 +236.11 13.7835718541831 3.11108823335309 0.806373906190005 +251.4 13.7844716424663 3.11108927532107 0.806399849709987 +266.33 13.7853714310523 3.1110903165185 0.79733554595718 +251.37 13.7862712199408 3.11109135694536 0.808278096014834 +241.09 13.7871710091315 3.11109239660165 0.808771224324862 +236.15 13.7880707986243 3.11109343548737 0.815981646263022 +233.33 13.7889705884189 3.11109447360252 0.816510413633805 +236.8 13.7898703785151 3.1110955109471 0.794184609917649 +245.34 13.7907701689127 3.11109654752111 0.797542503174301 +241.77 13.7916699596114 3.11109758332455 0.800381405857131 +251.77 13.792569750611 3.11109861835741 0.803960518484738 +247.86 13.7934695419114 3.1110996526197 0.819928656361474 +237.85 13.7943693335122 3.11110068611141 0.815563645319439 +232.24 13.7952691254133 3.11110171883254 0.822261729410857 +226.38 13.7961689176144 3.11110275078309 0.823717043763593 +215.38 13.7970687101153 3.11110378196306 0.80966568925028 +228.44 13.7979685029158 3.11110481237245 0.804687597037233 +233.18 13.7988682960157 3.11110584201125 0.804846879794859 +222.43 13.7997680894146 3.11110687087947 0.812092658349916 +225.56 13.8006678831125 3.1111078989771 0.818438348476645 +242.21 13.7115908902388 3.11009790504273 0.804510239556113 +236.12 13.7124906528129 3.11009900833016 0.808423773200828 +231.04 13.7133904157076 3.11010011084736 0.814159878654121 +230.89 13.7142901789227 3.11010121259432 0.823659319743705 +239.6 13.7151899424579 3.11010231357105 0.804001152793122 +239.11 13.7160897063132 3.11010341377754 0.804584030945096 +234.81 13.7169894704881 3.11010451321379 0.819768377331662 +229.06 13.7178892349826 3.1101056118798 0.818629776424319 +232.95 13.7187889997964 3.11010670977556 0.829595142288528 +236.3 13.7196887649292 3.11010780690108 0.824307730314546 +231.34 13.7205885303809 3.11010890325636 0.811497293852892 +233.49 13.7214882961511 3.11010999884139 0.810177823323164 +237.45 13.7223880622398 3.11011109365617 0.811171070369895 +238.24 13.7232878286466 3.11011218770071 0.813681827042752 +235.98 13.7241875953714 3.11011328097499 0.80322671721857 +231.75 13.7250873624139 3.11011437347902 0.815435366321442 +236.2 13.7259871297739 3.1101154652128 0.804085845492628 +240.68 13.7268868974512 3.11011655617632 0.795497008545254 +238.68 13.7277866654455 3.11011764636959 0.815357386394109 +247.77 13.7286864337566 3.1101187357926 0.811034913181416 +242.47 13.7295862023843 3.11011982444535 0.802674701551106 +248.49 13.7304859713284 3.11012091232785 0.805024150193732 +253.92 13.7313857405887 3.11012199944008 0.817536154332613 +250.97 13.7322855101649 3.11012308578205 0.812713493128332 +245.56 13.7331852800568 3.11012417135375 0.819355453921961 +249.89 13.7340850502641 3.11012525615519 0.799569096778123 +244.35 13.7349848207868 3.11012634018637 0.823187666394806 +241.12 13.7358845916244 3.11012742344727 0.811671773194152 +244.75 13.7367843627769 3.11012850593791 0.816194362295512 +246.36 13.7376841342439 3.11012958765827 0.811503528736153 +238.24 13.7385839060253 3.11013066860837 0.805070320182939 +233.06 13.7394836781209 3.11013174878819 0.803281402625784 +235.68 13.7403834505303 3.11013282819773 0.800596757924768 +231.64 13.7412832232535 3.110133906837 0.799731659813893 +231.19 13.7421829962901 3.11013498470599 0.793705448037185 +239.65 13.7430827696399 3.11013606180471 0.798223514077381 +228.53 13.7439825433028 3.11013713813314 0.816267119156567 +239.78 13.7448823172785 3.11013821369129 0.812755633660441 +236.41 13.7457820915667 3.11013928847916 0.812224556526135 +226.17 13.7466818661672 3.11014036249675 0.814372412321555 +234.44 13.7475816410799 3.11014143574405 0.79914081225451 +236.89 13.7484814163045 3.11014250822107 0.806342662525159 +241.42 13.7493811918408 3.11014357992779 0.79418570303269 +239.26 13.7502809676885 3.11014465086423 0.801472444763283 +241.37 13.7511807438474 3.11014572103038 0.814015267175573 +241.96 13.7520805203174 3.11014679042624 0.816096807026803 +241.6 13.7529802970981 3.1101478590518 0.80737430521716 +236.18 13.7538800741893 3.11014892690707 0.80509127053638 +230.29 13.7547798515909 3.11014999399204 0.817584454900672 +237.76 13.7556796293026 3.11015106030671 0.819284998131657 +256.7 13.7565794073242 3.11015212585109 0.795217649168789 +243.33 13.7574791856554 3.11015319062517 0.799052446367173 +248.3 13.7583789642961 3.11015425462894 0.803597986610885 +250.93 13.759278743246 3.11015531786242 0.790833668948852 +248.97 13.7601785225048 3.11015638032559 0.807213164595447 +235.8 13.7610783020725 3.11015744201845 0.806277820666546 +232.96 13.7619780819486 3.11015850294101 0.815592807937812 +245.99 13.7628778621331 3.11015956309326 0.810277658028772 +251.77 13.7637776426257 3.11016062247521 0.813000057067854 +249.24 13.7646774234261 3.11016168108684 0.805126307751651 +232.99 13.7655772045342 3.11016273892816 0.816009028094003 +241.29 13.7664769859497 3.11016379599917 0.828578668259398 +244.93 13.7673767676724 3.11016485229986 0.817963022905996 +233.57 13.768276549702 3.11016590783024 0.816483681045422 +249.23 13.7691763320384 3.1101669625903 0.8036936434697 +231.21 13.7700761146814 3.11016801658005 0.824806375575261 +233.09 13.7709758976306 3.11016906979947 0.817759957985005 +236.75 13.7718756808859 3.11017012224858 0.804708240443417 +231.2 13.772775464447 3.11017117392736 0.815859707179705 +239.39 13.7736752483138 3.11017222483582 0.824208574495717 +238.16 13.774575032486 3.11017327497395 0.837578290952059 +232.17 13.7754748169633 3.11017432434176 0.815838009962797 +240.58 13.7763746017456 3.11017537293924 0.807174184833952 +254.46 13.7772743868327 3.1101764207664 0.807426693186026 +245.74 13.7781741722242 3.11017746782322 0.811585691404164 +245.83 13.7790739579201 3.11017851410971 0.811255821541354 +242.14 13.7799737439199 3.11017955962587 0.809548979543536 +240.55 13.7808735302237 3.1101806043717 0.817399454035599 +229.92 13.781773316831 3.11018164834719 0.819346784975361 +225.65 13.7826731037417 3.11018269155235 0.815433610578983 +249.89 13.7835728909556 3.11018373398717 0.80460789167655 +260.86 13.7844726784724 3.11018477565165 0.79573078643609 +252.98 13.785372466292 3.11018581654579 0.797173686805061 +237 13.786272254414 3.11018685666959 0.810029291341096 +249.69 13.7871720428383 3.11018789602305 0.804982128385917 +239.91 13.7880718315646 3.11018893460616 0.823792366011738 +232.18 13.7889716205928 3.11018997241893 0.814526372614398 +240.5 13.7898714099226 3.11019100946135 0.804528480728218 +253.28 13.7907711995537 3.11019204573342 0.810679430410466 +243.53 13.791670989486 3.11019308123515 0.810409611727049 +255.46 13.7925707797192 3.11019411596652 0.80456524969424 +249.03 13.7934705702531 3.11019514992754 0.799283593995689 +256.67 13.7943703610874 3.11019618311821 0.794173563597864 +230.44 13.7952701522221 3.11019721553853 0.813009494581375 +227.28 13.7961699436567 3.11019824718849 0.802715538341306 +227.19 13.7970697353912 3.11019927806809 0.809900327617369 +228.63 13.7979695274252 3.11020030817734 0.80172585098152 +227.92 13.7988693197586 3.11020133751623 0.810646082163014 +222.58 13.7997691123911 3.11020236608476 0.81442610399078 +233.71 13.8006689053225 3.11020339388292 0.79888678458993 +235.64 13.7115919880013 3.1091934306687 0.806501812975614 +240.54 13.7124917498092 3.10919453363467 0.815694749785744 +240.03 13.7133915119378 3.10919563583063 0.811548793101489 +231.18 13.7142912743868 3.10919673725658 0.818738962555 +228.93 13.7151910371559 3.10919783791252 0.822617486650324 +233.45 13.716090800245 3.10919893779844 0.803810421062215 +231.45 13.7169905636539 3.10920003691435 0.812435668603194 +232.85 13.7178903273823 3.10920113526024 0.822751603061802 +234.85 13.7187900914299 3.10920223283612 0.817026847059536 +230.6 13.7196898557966 3.10920332964197 0.823749307043435 +230.91 13.7205896204822 3.10920442567781 0.806822065759792 +231.37 13.7214893854863 3.10920552094362 0.81534284296796 +245.28 13.7223891508089 3.10920661543941 0.810567005519523 +238.42 13.7232889164496 3.10920770916517 0.799773989718124 +231.23 13.7241886824082 3.10920880212091 0.813201898616368 +236.64 13.7250884486846 3.10920989430662 0.810279319950808 +233.34 13.7259882152784 3.10921098572231 0.810818596905251 +242.92 13.7268879821896 3.10921207636796 0.798837536097885 +243.58 13.7277877494178 3.10921316624358 0.812206783709811 +241.54 13.7286875169628 3.10921425534917 0.813626383508059 +240.08 13.7295872848244 3.10921534368472 0.807020020231962 +240.62 13.7304870530023 3.10921643125024 0.802991040821781 +257.76 13.7313868214965 3.10921751804572 0.81530926558363 +246.38 13.7322865903065 3.10921860407117 0.814100459020222 +245.17 13.7331863594322 3.10921968932657 0.832794454201927 +245.42 13.7340861288735 3.10922077381194 0.808588274641404 +235.45 13.73498589863 3.10922185752726 0.812262526310035 +238.01 13.7358856687015 3.10922294047254 0.811285136315392 +240.45 13.7367854390878 3.10922402264777 0.809241800982762 +243.8 13.7376852097887 3.10922510405296 0.789777208619915 +233.32 13.738584980804 3.1092261846881 0.794858383241363 +234.83 13.7394847521333 3.10922726455319 0.804854523714627 +239.72 13.7403845237766 3.10922834364823 0.803915460557845 +232.98 13.7412842957336 3.10922942197322 0.798721549880067 +229.84 13.7421840680041 3.10923049952815 0.815551169562074 +234.85 13.7430838405878 3.10923157631304 0.811254368565222 +235.9 13.7439836134845 3.10923265232786 0.8148188777709 +240.25 13.744883386694 3.10923372757263 0.819689363873887 +235.21 13.7457831602161 3.10923480204734 0.806925389363267 +234.67 13.7466829340505 3.109235875752 0.804810122506802 +237.77 13.747582708197 3.10923694868659 0.805665793287767 +235.09 13.7484824826554 3.10923802085112 0.810515507551947 +228.23 13.7493822574255 3.10923909224559 0.814942474463698 +230.55 13.7502820325071 3.10924016286999 0.816765845913855 +241.77 13.7511818078998 3.10924123272432 0.813715565372109 +237.86 13.7520815836036 3.10924230180859 0.810039543409699 +241.03 13.7529813596181 3.10924337012279 0.800858582417098 +235.12 13.7538811359432 3.10924443766692 0.802294714606417 +227.82 13.7547809125787 3.10924550444098 0.81212473213034 +238.32 13.7556806895242 3.10924657044496 0.829974129113772 +247.13 13.7565804667796 3.10924763567888 0.801098239922011 +250.14 13.7574802443447 3.10924870014271 0.803791821030616 +244.79 13.7583800222191 3.10924976383647 0.802960438655286 +252.7 13.7592798004029 3.10925082676015 0.803708472627471 +233.74 13.7601795788955 3.10925188891376 0.817538984576933 +227.99 13.761079357697 3.10925295029728 0.817521004820246 +238.19 13.761979136807 3.10925401091072 0.799860336926834 +243.93 13.7628789162253 3.10925507075408 0.804870163982123 +243.48 13.7637786959516 3.10925612982735 0.81899587595896 +238.87 13.7646784759859 3.10925718813054 0.80097297779002 +239.27 13.7655782563278 3.10925824566364 0.822803222577537 +249.29 13.7664780369771 3.10925930242665 0.805221844730093 +245.42 13.7673778179336 3.10926035841957 0.811713498013255 +243.96 13.7682775991971 3.10926141364241 0.812169176823389 +247.24 13.7691773807673 3.10926246809514 0.801464939202207 +231.23 13.770077162644 3.10926352177779 0.815103649054707 +236.04 13.770976944827 3.10926457469034 0.809102818610707 +246.95 13.7718767273161 3.1092656268328 0.802677919852778 +235.76 13.7727765101111 3.10926667820515 0.819394052159891 +228.21 13.7736762932117 3.10926772880741 0.814733922137551 +238.88 13.7745760766176 3.10926877863957 0.830387445640328 +243.39 13.7754758603288 3.10926982770163 0.837870124291965 +257.07 13.7763756443449 3.10927087599358 0.822256525595982 +262.01 13.7772754286657 3.10927192351543 0.821865826591251 +251.73 13.7781752132911 3.10927297026718 0.814028173674987 +251.49 13.7790749982207 3.10927401624882 0.801537310597985 +238.31 13.7799747834544 3.10927506146035 0.818310040720997 +233.12 13.7808745689919 3.10927610590177 0.814695430673921 +231.58 13.781774354833 3.10927714957308 0.823731025379492 +244.93 13.7826741409775 3.10927819247428 0.812134347812907 +244.18 13.7835739274252 3.10927923460537 0.802438512166805 +253.97 13.7844737141758 3.10928027596634 0.803733329237244 +241.58 13.7853735012291 3.1092813165572 0.814077885041525 +235.15 13.786273288585 3.10928235637794 0.820846794762796 +232 13.787173076243 3.10928339542856 0.818620596153474 +230.72 13.7880728642032 3.10928443370907 0.820106874030377 +228.69 13.7889726524651 3.10928547121945 0.816106241254275 +239.75 13.7898724410286 3.10928650795971 0.810173132376805 +231.27 13.7907722298935 3.10928754392985 0.813965107377412 +248.15 13.7916720190596 3.10928857912986 0.809440754215377 +254.32 13.7925718085266 3.10928961355975 0.809789999624328 +248.33 13.7934715982942 3.10929064721951 0.817176093624547 +246.85 13.7943713883624 3.10929168010914 0.800191921554081 +239.48 13.7952711787308 3.10929271222864 0.799071017498758 +231.16 13.7961709693992 3.10929374357802 0.798067702850714 +227.71 13.7970707603674 3.10929477415725 0.808363232981581 +222.41 13.7979705516352 3.10929580396636 0.801979433123315 +226.87 13.7988703432024 3.10929683300533 0.813181361694919 +227.96 13.7997701350687 3.10929786127417 0.799823588282191 +227.31 13.8006699272339 3.10929888877287 0.804892039169091 +237.53 13.7115930854428 3.10828895627875 0.815714639435161 +232.29 13.7124928464849 3.10829005892326 0.814171721849779 +236.83 13.7133926078476 3.10829116079798 0.818512597166327 +237.11 13.7142923695307 3.10829226190292 0.820039693790757 +233.66 13.715192131534 3.10829336223807 0.821445364102488 +235.17 13.7160918938572 3.10829446180343 0.817340123996919 +233.19 13.7169916565001 3.108295560599 0.812031978317673 +242.02 13.7178914194626 3.10829665862478 0.800906874543845 +234.69 13.7187911827444 3.10829775588076 0.820563963015415 +227.84 13.7196909463452 3.10829885236695 0.812070105157737 +233 13.7205907102648 3.10829994808334 0.81299497506936 +231.73 13.7214904745031 3.10830104302994 0.812816169526133 +240.24 13.7223902390597 3.10830213720673 0.808725096759904 +242.73 13.7232900039345 3.10830323061373 0.803801638797802 +237.94 13.7241897691273 3.10830432325093 0.818570064436575 +240.51 13.7250895346378 3.10830541511832 0.80524912920752 +247.3 13.7259893004657 3.1083065062159 0.795909321175279 +241.62 13.7268890666109 3.10830759654369 0.810922207042815 +244.85 13.7277888330732 3.10830868610166 0.808438586857038 +246.31 13.7286885998523 3.10830977488983 0.811769427962331 +243.41 13.729588366948 3.10831086290818 0.810039541274829 +242.27 13.7304881343601 3.10831195015673 0.806982204886379 +242.65 13.7313879020883 3.10831303663546 0.805458224738388 +236.84 13.7322876701324 3.10831412234438 0.806703248983459 +237.35 13.7331874384922 3.10831520728349 0.819965459221869 +239.13 13.7340872071675 3.10831629145278 0.805109186703262 +234.57 13.7349869761581 3.10831737485225 0.818707752728371 +228.91 13.7358867454637 3.1083184574819 0.809576138147567 +236.1 13.7367865150841 3.10831953934173 0.808426557146098 +237.82 13.7376862850191 3.10832062043174 0.797378807059349 +234.6 13.7385860552684 3.10832170075192 0.801381249741533 +238.93 13.7394858258319 3.10832278030229 0.811038243196991 +238.33 13.7403855967093 3.10832385908282 0.803272666419047 +240.31 13.7412853679003 3.10832493709353 0.808450682114319 +233.83 13.7421851394049 3.10832601433441 0.818084628375761 +247.67 13.7430849112226 3.10832709080546 0.799423697556478 +234.7 13.7439846833534 3.10832816650668 0.81517373606961 +238 13.744884455797 3.10832924143807 0.816928170322322 +235.06 13.7457842285531 3.10833031559963 0.809850998252812 +238.49 13.7466840016216 3.10833138899135 0.803355823863636 +242.95 13.7475837750022 3.10833246161323 0.800789546213583 +230.69 13.7484835486947 3.10833353346527 0.815964497272781 +227.61 13.7493833226988 3.10833460454748 0.817187518336404 +239.01 13.7502830970144 3.10833567485985 0.811808946725383 +236.2 13.7511828716413 3.10833674440237 0.810425388462925 +232.81 13.7520826465791 3.10833781317505 0.810470839357156 +235.58 13.7529824218277 3.10833888117789 0.803763484336336 +242.52 13.7538821973868 3.10833994841088 0.794506526354969 +237.69 13.7547819732563 3.10834101487403 0.814292251666071 +240.53 13.7556817494359 3.10834208056732 0.820599837677658 +254.02 13.7565815259253 3.10834314549077 0.803443028910702 +252.17 13.7574813027244 3.10834420964437 0.816766037629721 +245.45 13.758381079833 3.10834527302811 0.808029737434831 +248.69 13.7592808572507 3.108346335642 0.805722570466078 +234.2 13.7601806349775 3.10834739748604 0.810343788059665 +234.71 13.761080413013 3.10834845856022 0.80101894253029 +239.55 13.761980191357 3.10834951886454 0.807029013461109 +252.6 13.7628799700093 3.10835057839901 0.801549390289905 +231.95 13.7637797489697 3.10835163716361 0.819095052208527 +227.09 13.764679528238 3.10835269515835 0.814096147223935 +234.94 13.765579307814 3.10835375238323 0.81775291604555 +237.86 13.7664790876973 3.10835480883825 0.809867306104551 +253.25 13.7673788678878 3.1083558645234 0.8079714474024 +254.49 13.7682786483853 3.10835691943869 0.811586627138515 +239.28 13.7691784291896 3.1083579735841 0.811029240673233 +237.1 13.7700782103003 3.10835902695965 0.823897393277103 +241.95 13.7709779917174 3.10836007956533 0.816598352656439 +246.32 13.7718777734405 3.10836113140113 0.810172209796422 +238.91 13.7727775554695 3.10836218246707 0.804160934657108 +230.24 13.7736773378041 3.10836323276312 0.820838730883007 +227.01 13.7745771204441 3.10836428228931 0.826443347949032 +239.38 13.7754769033893 3.10836533104561 0.821680682811987 +239.95 13.7763766866394 3.10836637903204 0.815941703514981 +251.59 13.7772764701943 3.10836742624859 0.816507567374955 +259.3 13.7781762540537 3.10836847269526 0.827147846332945 +252.98 13.7790760382173 3.10836951837204 0.832189403871366 +244.01 13.779975822685 3.10837056327894 0.8143233642718 +237.41 13.7808756074565 3.10837160741596 0.811663682396658 +227.04 13.7817753925317 3.10837265078309 0.82256760813838 +233.6 13.7826751779102 3.10837369338034 0.816442628114149 +233.82 13.7835749635919 3.10837473520769 0.81087534130842 +250.14 13.7844747495765 3.10837577626516 0.79395408468239 +243.24 13.7853745358638 3.10837681655274 0.811204300151177 +229.6 13.7862743224537 3.10837785607042 0.825809133914894 +231.42 13.7871741093457 3.10837889481821 0.823884333870913 +229.7 13.7880738965399 3.1083799327961 0.826812901472664 +236.6 13.7889736840358 3.1083809700041 0.821067722035397 +247.79 13.7898734718334 3.1083820064422 0.801044212831694 +249.09 13.7907732599323 3.1083830421104 0.799188706536407 +248.69 13.7916730483323 3.1083840770087 0.808312409399044 +256.7 13.7925728370333 3.10838511113711 0.807523087318868 +247.34 13.793472626035 3.1083861444956 0.803538212212899 +239.65 13.7943724153371 3.1083871770842 0.808326575851545 +241.75 13.7952722049395 3.10838820890289 0.803674997256555 +220.5 13.7961719948419 3.10838923995167 0.812428939393313 +229.75 13.7970717850441 3.10839027023055 0.813124429643149 +231.76 13.7979715755459 3.10839129973951 0.804800038671006 +224.09 13.7988713663471 3.10839232847857 0.824348765825872 +226.94 13.7997711574473 3.10839335644771 0.805084884367538 +231.73 13.8006709488465 3.10839438364694 0.840765141472168 +243.92 13.7115941825636 3.10738448187289 0.813810368206947 +243.86 13.71249394284 3.10738558419594 0.797602774109343 +242.53 13.713393703437 3.10738668574943 0.805710757597701 +235.21 13.7142934643544 3.10738778653335 0.809112784289374 +232.96 13.715193225592 3.10738888654771 0.817265397253974 +234.42 13.7160929871496 3.10738998579251 0.820545527357945 +241.29 13.7169927490269 3.10739108426774 0.804198858416542 +233.08 13.7178925112237 3.1073921819734 0.815185818606293 +224.66 13.7187922737398 3.1073932789095 0.811510404827344 +230.05 13.7196920365749 3.10739437507602 0.81745785784058 +234.8 13.7205917997289 3.10739547047297 0.812446808916638 +233.56 13.7214915632015 3.10739656510035 0.817931390060213 +242.15 13.7223913269924 3.10739765895815 0.798698298075643 +239.25 13.7232910911016 3.10739875204638 0.789064461592541 +234.25 13.7241908555287 3.10739984436503 0.813059791347849 +231.24 13.7250906202734 3.1074009359141 0.803895242831096 +234.13 13.7259903853357 3.1074020266936 0.80013094409021 +235.7 13.7268901507153 3.10740311670351 0.80878149133054 +241.38 13.7277899164119 3.10740420594384 0.804336835669748 +247.72 13.7286896824253 3.10740529441458 0.806859288428957 +246.64 13.7295894487553 3.10740638211574 0.80584503132683 +240.21 13.7304892154016 3.10740746904732 0.802010147534504 +231.73 13.7313889823642 3.1074085552093 0.811956938410427 +232.01 13.7322887496426 3.1074096406017 0.816721173239741 +237.06 13.7331885172368 3.1074107252245 0.817665719206588 +231.11 13.7340882851464 3.10741180907771 0.803136533668429 +235.94 13.7349880533712 3.10741289216134 0.815826820749989 +232.7 13.7358878219111 3.10741397447536 0.811930022661868 +235.81 13.7367875907658 3.10741505601979 0.804929178697788 +238.6 13.7376873599351 3.10741613679462 0.799806840455922 +227.93 13.7385871294188 3.10741721679986 0.809473892165835 +241.51 13.7394868992165 3.10741829603549 0.807467372448881 +246.37 13.7403866693282 3.10741937450152 0.806074203457207 +239.53 13.7412864397536 3.10742045219795 0.821708646726139 +237.73 13.7421862104924 3.10742152912478 0.821423685193334 +243.3 13.7430859815445 3.107422605282 0.814078468443657 +246.32 13.7439857529095 3.10742368066961 0.81253801703163 +242.68 13.7448855245874 3.10742475528762 0.798153871177619 +237.28 13.7457852965778 3.10742582913602 0.809006707122325 +236.8 13.7466850688806 3.1074269022148 0.806766273889061 +234.93 13.7475848414955 3.10742797452398 0.804919140208518 +240.97 13.7484846144222 3.10742904606354 0.80914021719095 +240.48 13.7493843876607 3.10743011683349 0.8070952915062 +243.82 13.7502841612106 3.10743118683382 0.804619043480322 +239.26 13.7511839350717 3.10743225606453 0.811224550958023 +242.77 13.7520837092438 3.10743332452563 0.806334474894915 +243.43 13.7529834837267 3.1074343922171 0.81360115818878 +239.71 13.7538832585201 3.10743545913896 0.809529902909516 +249.57 13.7547830336238 3.10743652529119 0.808230527748007 +237.98 13.7556828090377 3.1074375906738 0.81376015400319 +250.45 13.7565825847614 3.10743865528678 0.814297837474029 +252.32 13.7574823607948 3.10743971913014 0.800097480503899 +246.93 13.7583821371376 3.10744078220387 0.806586067566167 +244.67 13.7592819137896 3.10744184450797 0.816321943302563 +237.14 13.7601816907506 3.10744290604244 0.814766023254482 +235.83 13.7610814680204 3.10744396680727 0.80201281188211 +246.73 13.7619812455987 3.10744502680248 0.798522642115405 +234.54 13.7628810234853 3.10744608602805 0.800346441479705 +232.76 13.76378080168 3.10744714448399 0.806464848718601 +221.41 13.7646805801825 3.10744820217028 0.818827978524799 +239.25 13.7655803589927 3.10744925908695 0.809401877233633 +238.17 13.7664801381103 3.10745031523397 0.806313968574312 +245.18 13.7673799175351 3.10745137061135 0.808434178420859 +238.91 13.7682796972669 3.10745242521908 0.818211248010421 +248.09 13.7691794773054 3.10745347905718 0.810351941793514 +239.91 13.7700792576504 3.10745453212563 0.814535234821387 +252.22 13.7709790383017 3.10745558442443 0.813016663989571 +241.91 13.7718788192591 3.10745663595359 0.805880249289781 +229.84 13.7727786005223 3.1074576867131 0.806904139733187 +229.41 13.7736783820912 3.10745873670296 0.819074404335901 +230.26 13.7745781639654 3.10745978592317 0.823897280499683 +240.86 13.7754779461449 3.10746083437372 0.825402667765967 +250.02 13.7763777286292 3.10746188205462 0.815486800382761 +249.27 13.7772775114183 3.10746292896587 0.812055674274371 +246.71 13.7781772945119 3.10746397510746 0.809372475498041 +241.23 13.7790770779098 3.10746502047939 0.819564392054523 +240.8 13.7799768616118 3.10746606508167 0.833549550186465 +234.04 13.7808766456175 3.10746710891428 0.821251458851879 +226.36 13.7817764299269 3.10746815197723 0.823029969250539 +233.56 13.7826762145397 3.10746919427052 0.813517560469336 +236.39 13.7835759994556 3.10747023579415 0.808097152889587 +252.47 13.7844757846745 3.10747127654811 0.804824648384512 +237.79 13.785375570196 3.1074723165324 0.821717296822573 +229.93 13.7862753560201 3.10747335574703 0.822215653057125 +232.33 13.7871751421464 3.10747439419198 0.832188516063085 +241.86 13.7880749285748 3.10747543186727 0.816681641782485 +245.88 13.7889747153049 3.10747646877288 0.795358580733855 +239.42 13.7898745023367 3.10747750490882 0.803280725736299 +248.33 13.7907742896698 3.10747854027509 0.79636819443427 +251.82 13.7916740773041 3.10747957487168 0.814106804251003 +247.34 13.7925738652393 3.1074806086986 0.807271223341579 +244.03 13.7934736534752 3.10748164175583 0.789612702056109 +249.34 13.7943734420116 3.10748267404339 0.78385450519774 +235.15 13.7952732308482 3.10748370556127 0.817574032021947 +226.46 13.7961730199848 3.10748473630946 0.809649148060259 +230.17 13.7970728094212 3.10748576628797 0.808303003172502 +234.78 13.7979725991572 3.1074867954968 0.816091699919309 +227.52 13.7988723891926 3.10748782393594 0.804162760487827 +228.49 13.7997721795271 3.10748885160539 0.819659347107693 +246.28 13.8006719701605 3.10748987850516 0.822390658609034 +239.82 13.7115952793634 3.10648000745112 0.816341807080373 +236.05 13.7124950388744 3.10648110945271 0.811991556848651 +241.58 13.713394798706 3.10648221068496 0.812402076170816 +234.21 13.714294558858 3.10648331114787 0.809859154929577 +235.16 13.7151943193302 3.10648441084145 0.813131602137862 +238.44 13.7160940801223 3.10648550976568 0.810497030250884 +238.69 13.7169938412341 3.10648660792057 0.821236007630565 +233.64 13.7178936026655 3.10648770530612 0.814994884261218 +234.04 13.7187933644161 3.10648880192233 0.814348741025808 +232.43 13.7196931264858 3.10648989776918 0.809411523477548 +235.4 13.7205928888743 3.1064909928467 0.813670192081869 +241.77 13.7214926515815 3.10649208715486 0.803227868947746 +234.77 13.722392414607 3.10649318069367 0.814196558410082 +237.67 13.7232921779507 3.10649427346313 0.810088124992743 +241.82 13.7241919416123 3.10649536546324 0.808043529690088 +238.46 13.7250917055916 3.10649645669399 0.796847434540367 +239.4 13.7259914698885 3.10649754715539 0.791674324572689 +235.6 13.7268912345025 3.10649863684743 0.802863266874267 +241.24 13.7277909994337 3.10649972577012 0.814434313599589 +242.91 13.7286907646816 3.10650081392344 0.80388044469623 +248.58 13.7295905302462 3.1065019013074 0.807868729330886 +236.65 13.7304902961271 3.106502987922 0.809374633803367 +236.83 13.7313900623241 3.10650407376724 0.803906714141604 +232.58 13.7322898288371 3.10650515884311 0.811131033436228 +239.94 13.7331895956658 3.10650624314962 0.803160256761089 +239.24 13.7340893628099 3.10650732668676 0.814315250566112 +248 13.7349891302693 3.10650840945453 0.80352585525916 +240.47 13.7358888980438 3.10650949145293 0.800672318151402 +241.76 13.736788666133 3.10651057268196 0.813035157411573 +238.55 13.7376884345368 3.10651165314161 0.80739869876955 +237.5 13.738588203255 3.1065127328319 0.812734462526984 +241.39 13.7394879722873 3.1065138117528 0.814691776382793 +241.15 13.7403877416335 3.10651488990433 0.807774888935735 +240.3 13.7412875112934 3.10651596728648 0.81787051822268 +238.45 13.7421872812667 3.10651704389925 0.817185240126089 +237.8 13.7430870515533 3.10651811974264 0.805884034923482 +239.93 13.7439868221529 3.10651919481665 0.814726769378912 +236.66 13.7448865930652 3.10652026912128 0.819966946380101 +229.67 13.7457863642902 3.10652134265652 0.816663525864506 +240.81 13.7466861358275 3.10652241542237 0.810658991202618 +242.94 13.7475859076768 3.10652348741884 0.79581806772868 +245.7 13.7484856798381 3.10652455864592 0.80029691449665 +245.54 13.7493854523111 3.1065256291036 0.81609049361171 +243.88 13.7502852250955 3.1065266987919 0.804720328603553 +236.22 13.7511849981911 3.1065277677108 0.81742080925745 +239.85 13.7520847715977 3.10652883586031 0.817495280050346 +248.2 13.7529845453151 3.10652990324043 0.804907856072547 +246.08 13.753884319343 3.10653096985114 0.798810897576675 +238.94 13.7547840936813 3.10653203569246 0.808243976609116 +238.8 13.7556838683296 3.10653310076438 0.814971978194218 +246.43 13.7565836432879 3.1065341650669 0.81252994948368 +248.27 13.7574834185557 3.10653522860002 0.798542168534035 +253.03 13.758383194133 3.10653629136374 0.802668311748146 +241.19 13.7592829700196 3.10653735335805 0.808322037314406 +236.47 13.7601827462151 3.10653841458295 0.814570522110376 +233.86 13.7610825227193 3.10653947503845 0.810700212790591 +241.93 13.7619822995321 3.10654053472454 0.800254206960664 +215.92 13.7628820766532 3.10654159364122 0.819866115056355 +229.03 13.7637818540824 3.10654265178848 0.802131878188073 +241.94 13.7646816318194 3.10654370916634 0.80265459908281 +245.5 13.7655814098641 3.10654476577478 0.808020291929912 +239.53 13.7664811882162 3.10654582161381 0.806582722666892 +222.17 13.7673809668754 3.10654687668342 0.820462797589841 +224.02 13.7682807458417 3.10654793098361 0.81609515425717 +235.01 13.7691805251147 3.10654898451438 0.801318479576084 +248.5 13.7700803046942 3.10655003727573 0.812802315060492 +246.34 13.7709800845799 3.10655108926767 0.821532328648235 +235.26 13.7718798647718 3.10655214049018 0.806863235843285 +224.14 13.7727796452695 3.10655319094326 0.824371831116646 +231.64 13.7736794260728 3.10655424062692 0.813931367810537 +228.89 13.7745792071816 3.10655528954115 0.810276615950375 +243.72 13.7754789885955 3.10655633768596 0.808067464401468 +252.84 13.7763787703143 3.10655738506133 0.815888223552894 +253.74 13.7772785523379 3.10655843166728 0.805190860824802 +239.93 13.778178334666 3.10655947750379 0.81333292531787 +238.37 13.7790781172983 3.10656052257087 0.815433171004063 +240.74 13.7799779002347 3.10656156686852 0.84198268576866 +229.38 13.7808776834749 3.10656261039673 0.826322290847838 +226.4 13.7817774670188 3.1065636531555 0.822133239359169 +234.84 13.782677250866 3.10656469514484 0.807661389682209 +243.11 13.7835770350164 3.10656573636473 0.815662618865738 +258.48 13.7844768194697 3.10656677681519 0.80822569908029 +242.82 13.7853766042257 3.1065678164962 0.821101353475822 +227.95 13.7862763892842 3.10656885540777 0.832418019163788 +231.07 13.787176174645 3.10656989354989 0.821949764425136 +245.22 13.7880759603078 3.10657093092257 0.816075807993 +253.44 13.7889757462725 3.1065719675258 0.803129673479561 +246.01 13.7898755325387 3.10657300335958 0.812573303385946 +242.83 13.7907753191063 3.10657403842391 0.810843870947826 +256.22 13.791675105975 3.10657507271879 0.79950907973446 +239.09 13.7925748931446 3.10657610624422 0.804652926003148 +237.2 13.793474680615 3.1065771390002 0.790371053901442 +246.17 13.7943744683858 3.10657817098672 0.801633100805735 +244.43 13.7952742564568 3.10657920220378 0.796722249468694 +238.37 13.7961740448279 3.10658023265139 0.805362470609156 +228.39 13.7970738334988 3.10658126232954 0.818876368331718 +226.96 13.7979736224692 3.10658229123823 0.81727118947951 +234.87 13.798873411739 3.10658331937745 0.811071121195525 +236.1 13.7997732013079 3.10658434674722 0.821008359023449 +242.05 13.8006729911758 3.10658537334752 0.825296361491955 +241.68 13.7115963758425 3.10557553301345 0.829103255063036 +242.49 13.7124961345882 3.10557663469357 0.817455299562479 +234.16 13.7133958936546 3.10557773560459 0.818601041000822 +229.6 13.7142956530414 3.10557883574649 0.822986062248305 +231.59 13.7151954127483 3.10557993511928 0.823259928369029 +231.82 13.7160951727752 3.10558103372295 0.821738435162906 +227.53 13.7169949331219 3.10558213155751 0.80869060211976 +230.12 13.717894693788 3.10558322862294 0.801621258389119 +238.64 13.7187944547734 3.10558432491926 0.80911862559846 +234.76 13.7196942160779 3.10558542044645 0.812116762093719 +239.06 13.7205939777012 3.10558651520452 0.805381162353334 +232.12 13.7214937396431 3.10558760919347 0.816922743994806 +238.57 13.7223935019034 3.10558870241329 0.817649375656436 +233.94 13.7232932644818 3.10558979486398 0.814976941105315 +243.87 13.7241930273782 3.10559088654555 0.805179886371159 +231.26 13.7250927905923 3.10559197745798 0.813551704800805 +240.2 13.7259925541239 3.10559306760129 0.805205762205052 +238.49 13.7268923179728 3.10559415697546 0.806638864940567 +239.8 13.7277920821387 3.1055952455805 0.802972327843683 +235 13.7286918466214 3.1055963334164 0.80057140491077 +248.67 13.7295916114207 3.10559742048317 0.789952145452217 +236.92 13.7304913765364 3.1055985067808 0.79701634405484 +228.77 13.7313911419682 3.10559959230929 0.806413043923332 +231.28 13.7322909077159 3.10560067706864 0.817290020395028 +239.91 13.7331906737794 3.10560176105885 0.814164776965815 +237.48 13.7340904401583 3.10560284427991 0.808418180240857 +239.21 13.7349902068524 3.10560392673183 0.822461624018766 +239.69 13.7358899738616 3.10560500841461 0.813705170719725 +236.99 13.7367897411856 3.10560608932824 0.810128197691282 +242.8 13.7376895088241 3.10560716947272 0.792223099873536 +244.85 13.7385892767771 3.10560824884804 0.807803709264061 +236.94 13.7394890450441 3.10560932745422 0.814325645579247 +243.5 13.740388813625 3.10561040529125 0.80536928147055 +241.56 13.7412885825197 3.10561148235912 0.797070852615482 +242.63 13.7421883517278 3.10561255865784 0.809232194914763 +244.73 13.7430881212491 3.1056136341874 0.797434587439696 +240.88 13.7439878910834 3.1056147089478 0.813568866889949 +235.47 13.7448876612305 3.10561578293905 0.810368767182148 +233.71 13.7457874316902 3.10561685616113 0.80975906689968 +236.12 13.7466872024622 3.10561792861405 0.812232489610586 +235.62 13.7475869735463 3.10561900029781 0.813448523675381 +243.02 13.7484867449424 3.10562007121241 0.799697145816777 +242.33 13.74938651665 3.10562114135784 0.810078365165593 +242.58 13.7502862886692 3.1056222107341 0.817289737289737 +246.82 13.7511860609995 3.1056232793412 0.801677573388911 +250.65 13.7520858336409 3.10562434717912 0.807280920735159 +250.37 13.752985606593 3.10562541424787 0.806461859072439 +243.45 13.7538853798556 3.10562648054745 0.811993268497257 +235.85 13.7547851534286 3.10562754607786 0.808816156840368 +245.79 13.7556849273117 3.10562861083909 0.806277249838041 +251.82 13.7565847015046 3.10562967483115 0.816544971206924 +251.51 13.7574844760072 3.10563073805403 0.808026745475841 +240.93 13.7583842508193 3.10563180050773 0.80398250088787 +230.34 13.7592840259405 3.10563286219225 0.806300080688327 +227.06 13.7601838013707 3.10563392310759 0.813669575115329 +233.55 13.7610835771097 3.10563498325375 0.814849733907853 +230.19 13.7619833531572 3.10563604263072 0.81065715197776 +223.8 13.762883129513 3.1056371012385 0.813985461311116 +235.68 13.7637829061769 3.1056381590771 0.813387275332118 +248.26 13.7646826831486 3.10563921614652 0.798355905234089 +250.28 13.765582460428 3.10564027244674 0.809915661579035 +238.92 13.7664822380148 3.10564132797777 0.798793941505334 +221.72 13.7673820159088 3.10564238273961 0.809360930705854 +229.44 13.7682817941097 3.10564343673226 0.815831911011712 +235.31 13.7691815726174 3.10564448995571 0.812166497113702 +231.44 13.7700813514316 3.10564554240997 0.815608311911564 +237.36 13.7709811305521 3.10564659409503 0.819411111577453 +227.92 13.7718809099787 3.10564764501089 0.827211381593076 +223.04 13.7727806897111 3.10564869515755 0.822571086559783 +223.72 13.7736804697491 3.10564974453501 0.815436255380613 +243.61 13.7745802500925 3.10565079314327 0.802954908465414 +231.7 13.7754800307411 3.10565184098233 0.823584425689831 +246.58 13.7763798116947 3.10565288805218 0.810755736009499 +256.13 13.7772795929529 3.10565393435282 0.803542746830565 +236.35 13.7781793745157 3.10565497988426 0.827356851570508 +236.55 13.7790791563827 3.10565602464649 0.815005154559862 +238.72 13.7799789385538 3.10565706863951 0.832490558341363 +232.3 13.7808787210288 3.10565811186331 0.820929453521678 +237.33 13.7817785038073 3.10565915431791 0.794607448073348 +251.06 13.7826782868892 3.10566019600329 0.77407430612117 +245.52 13.7835780702743 3.10566123691945 0.798691093146777 +249.27 13.7844778539622 3.1056622770664 0.808161557857409 +247.37 13.785377637953 3.10566331644413 0.814265504495049 +237.62 13.7862774222461 3.10566435505265 0.834562679096913 +232.43 13.7871772068416 3.10566539289194 0.83095703300052 +244.42 13.7880769917391 3.10566642996201 0.813603865612409 +244.72 13.7889767769384 3.10566746626285 0.813785604252877 +251.74 13.7898765624393 3.10566850179448 0.816061934521033 +260.03 13.7907763482415 3.10566953655688 0.785988472279993 +267.75 13.7916761343449 3.10567057055005 0.801963929423731 +234.84 13.7925759207492 3.10567160377399 0.802912362989205 +234.33 13.7934757074543 3.10567263622871 0.813127589700728 +232.34 13.7943754944597 3.10567366791419 0.812256981978348 +241.95 13.7952752817654 3.10567469883044 0.804315452863906 +247.19 13.7961750693712 3.10567572897746 0.809206667273887 +225.12 13.7970748572767 3.10567675835525 0.816000913303126 +224.91 13.7979746454818 3.1056777869638 0.81542067326987 +232.1 13.7988744339863 3.10567881480311 0.817032235552033 +239.83 13.7997742227899 3.10567984187318 0.843050229418583 +239.11 13.8006740118924 3.10568086817402 0.81031120347572 +238.93 13.7115974720006 3.10467105855988 0.81927352014384 +241.26 13.7124972299814 3.10467215991854 0.81856914610332 +235.67 13.7133969882828 3.10467326050833 0.819143992204482 +233.39 13.7142967469046 3.10467436032922 0.815258882819437 +224.32 13.7151965058465 3.10467545938122 0.817199538055085 +228.77 13.7160962651085 3.10467655766433 0.810796268990812 +223.27 13.7169960246901 3.10467765517855 0.812717661948762 +229.76 13.7178957845912 3.10467875192387 0.812754399024375 +235.05 13.7187955448117 3.10467984790029 0.800710038020343 +229.83 13.7196953053511 3.10468094310782 0.813814529710775 +235.28 13.7205950662094 3.10468203754645 0.816573473495862 +235.58 13.7214948273863 3.10468313121619 0.812284492667004 +237.91 13.7223945888816 3.10468422411701 0.818951842096464 +241.17 13.7232943506951 3.10468531624894 0.816790241569003 +239.27 13.7241941128265 3.10468640761197 0.811397925595619 +239.67 13.7250938752756 3.10468749820608 0.813619407136024 +235.18 13.7259936380421 3.1046885880313 0.81545382335869 +240.43 13.726893401126 3.1046896770876 0.80219945349789 +229.02 13.7277931645269 3.10469076537499 0.801225151034459 +237.83 13.7286929282446 3.10469185289348 0.805725476921589 +239.85 13.7295926922789 3.10469293964305 0.829447523253827 +235.22 13.7304924566295 3.10469402562371 0.807536461854201 +234.93 13.7313922212963 3.10469511083545 0.814653874284731 +235.54 13.732291986279 3.10469619527828 0.811957084946204 +247.82 13.7331917515774 3.10469727895219 0.79838165879973 +235.6 13.7340915171913 3.10469836185718 0.805449556908133 +238.81 13.7349912831205 3.10469944399325 0.824791024677781 +241.24 13.7358910493646 3.1047005253604 0.804840220754375 +242.68 13.7367908159236 3.10470160595863 0.804181195614614 +245.73 13.7376905827971 3.10470268578793 0.801211988349879 +243.46 13.738590349985 3.10470376484831 0.803302225412778 +242.46 13.739490117487 3.10470484313976 0.798460489917011 +248.28 13.7403898853029 3.10470592066229 0.805559401295245 +245.99 13.7412896534325 3.10470699741588 0.801297472949691 +236.34 13.7421894218756 3.10470807340055 0.810648720057051 +239.66 13.7430891906319 3.10470914861628 0.801878911925509 +237.88 13.7439889597012 3.10471022306308 0.808167775684292 +235.01 13.7448887290832 3.10471129674094 0.801600195443718 +237.53 13.7457884987779 3.10471236964987 0.804237311640918 +240.48 13.7466882687849 3.10471344178986 0.80499010404661 +236.81 13.7475880391039 3.10471451316091 0.811759118165087 +242.7 13.7484878097349 3.10471558376303 0.814814814814815 +247.79 13.7493875806776 3.1047166535962 0.803556243049704 +243.04 13.7502873519317 3.10471772266043 0.811460050120787 +237.82 13.7511871234969 3.10471879095571 0.814731110014876 +249.11 13.7520868953732 3.10471985848205 0.803277663590112 +241 13.7529866675603 3.10472092523944 0.809164701149335 +238.96 13.7538864400579 3.10472199122789 0.806853882929573 +239.89 13.7547862128658 3.10472305644739 0.802773801885396 +249.2 13.7556859859839 3.10472412089793 0.793637846655791 +251.28 13.7565857594118 3.10472518457953 0.810696951975833 +251.12 13.7574855331493 3.10472624749217 0.814652359892699 +235.28 13.7583853071963 3.10472730963585 0.807350386316385 +229.43 13.7592850815525 3.10472837101058 0.807705839517587 +236.07 13.7601848562176 3.10472943161636 0.816911813051869 +244.33 13.7610846311915 3.10473049145317 0.80640262179769 +236.68 13.761984406474 3.10473155052103 0.811166252094839 +239.86 13.7628841820647 3.10473260881992 0.798962452693796 +240.5 13.7637839579635 3.10473366634986 0.798853777626205 +263.6 13.7646837341702 3.10473472311083 0.778110810205453 +257.67 13.7655835106845 3.10473577910283 0.798232145732136 +251.09 13.7664832875063 3.10473683432587 0.801947012486018 +247.97 13.7673830646352 3.10473788877994 0.800127456358298 +235.58 13.7682828420711 3.10473894246504 0.807210333526123 +240.57 13.7691826198137 3.10473999538118 0.803490815454814 +249.13 13.7700823978628 3.10474104752834 0.809756212018114 +226.37 13.7709821762182 3.10474209890653 0.818939919903665 +225.6 13.7718819548797 3.10474314951574 0.815155804573001 +225.73 13.772781733847 3.10474419935598 0.829911322692056 +227.49 13.77368151312 3.10474524842724 0.828258298921579 +231.59 13.7745812926983 3.10474629672953 0.820991948736655 +239.06 13.7754810725818 3.10474734426283 0.821754878769959 +251.08 13.7763808527703 3.10474839102716 0.81359465907979 +250.98 13.7772806332635 3.1047494370225 0.816221813906158 +239.67 13.7781804140612 3.10475048224886 0.823525521376817 +238.8 13.7790801951631 3.10475152670624 0.823053816259224 +233.91 13.7799799765691 3.10475257039463 0.818467031297478 +228.59 13.7808797582789 3.10475361331404 0.833043478260869 +217.81 13.7817795402924 3.10475465546445 0.82124908553071 +235.3 13.7826793226092 3.10475569684588 0.809861954896784 +236.87 13.7835791052292 3.10475673745832 0.822716760814346 +250.52 13.7844788881521 3.10475777730176 0.832771531800658 +249.11 13.7853786713777 3.10475881637621 0.829495014249977 +228.75 13.7862784549058 3.10475985468167 0.8273970281015 +243.34 13.7871782387361 3.10476089221813 0.823197097342282 +246.11 13.7880780228685 3.10476192898559 0.81355230789274 +241.84 13.7889778073027 3.10476296498406 0.80574434372763 +244.55 13.7898775920385 3.10476400021352 0.804077329212543 +250.21 13.7907773770757 3.10476503467399 0.795373556532494 +253.32 13.791677162414 3.10476606836545 0.797107299567669 +247.91 13.7925769480532 3.10476710128791 0.807686103408279 +242.66 13.7934767339931 3.10476813344136 0.820625880109254 +239.86 13.7943765202334 3.10476916482581 0.821646790410188 +238.17 13.7952763067741 3.10477019544125 0.820335094317207 +228.57 13.7961760936147 3.10477122528768 0.814628102878428 +220.74 13.7970758807551 3.10477225436511 0.813557539841098 +228.25 13.7979756681951 3.10477328267352 0.804591083794172 +232.05 13.7988754559345 3.10477431021292 0.820883809897494 +246.58 13.7997752439729 3.1047753369833 0.820483945689747 +237.58 13.8006750323103 3.10477636298467 0.818124885838791 +233.99 13.711598567838 3.10376658409041 0.826241597125637 +237.44 13.712498325054 3.10376768512762 0.817330436166708 +224.34 13.7133980825906 3.10376878539617 0.813653844583616 +229.35 13.7142978404476 3.10376988489605 0.805925549943102 +228.68 13.7151975986248 3.10377098362726 0.810106600821474 +223.48 13.716097357122 3.10377208158981 0.817719271828117 +226.63 13.7169971159388 3.10377317878369 0.814784826035989 +239.29 13.7178968750752 3.1037742752089 0.811827997899815 +234.64 13.7187966345308 3.10377537086544 0.825219011716324 +236.91 13.7196963943055 3.10377646575331 0.815705170335263 +238.36 13.7205961543991 3.1037775598725 0.808155975591606 +229.03 13.7214959148112 3.10377865322301 0.818430394871382 +236.65 13.7223956755417 3.10377974580485 0.80051681222621 +241.49 13.7232954365904 3.10378083761801 0.803682504226969 +242.31 13.724195197957 3.1037819286625 0.806213308940171 +240.6 13.7250949596413 3.1037830189383 0.817651447832657 +241.96 13.7259947216431 3.10378410844542 0.809104738723663 +237.76 13.7268944839621 3.10378519718385 0.795689584528395 +240.37 13.7277942465982 3.1037862851536 0.804373036286811 +243.72 13.7286940095511 3.10378737235467 0.804472121353411 +243.92 13.7295937728206 3.10378845878704 0.809281804765243 +237.24 13.7304935364065 3.10378954445073 0.81171033073207 +236.06 13.7313933003085 3.10379062934573 0.817161540850034 +248.41 13.7322930645264 3.10379171347203 0.804281579128256 +242.52 13.7331928290601 3.10379279682965 0.808671966158181 +235.61 13.7340925939092 3.10379387941857 0.801064255124458 +229.37 13.7349923590735 3.10379496123879 0.821357254531664 +242.47 13.7358921245528 3.10379604229032 0.808873905714752 +240.96 13.736791890347 3.10379712257314 0.820398849387157 +243.77 13.7376916564557 3.10379820208727 0.809158664462396 +239.14 13.7385914228788 3.1037992808327 0.809729217277952 +238.63 13.739491189616 3.10380035880943 0.800256450300425 +238.09 13.7403909566671 3.10380143601745 0.803939170138365 +237.66 13.7412907240319 3.10380251245677 0.804243518428158 +244.38 13.7421904917102 3.10380358812738 0.795060546946888 +244.3 13.7430902597017 3.10380466302928 0.795464568949618 +235.96 13.7439900280061 3.10380573716248 0.812718138137198 +231.01 13.7448897966234 3.10380681052696 0.803333649097806 +239.04 13.7457895655532 3.10380788312273 0.807484949937914 +247.11 13.7466893347954 3.10380895494979 0.805087349999232 +238.1 13.7475891043497 3.10381002600814 0.807473532373513 +238.63 13.7484888742158 3.10381109629777 0.817461199676488 +253.36 13.7493886443936 3.10381216581868 0.808650503609947 +251.36 13.7502884148829 3.10381323457088 0.806452336197135 +244.22 13.7511881856834 3.10381430255435 0.805683105848537 +246.59 13.7520879567949 3.10381536976911 0.797163648391632 +240.43 13.7529877282171 3.10381643621514 0.816826322992015 +238.2 13.7538874999499 3.10381750189245 0.796718107689197 +245.84 13.754787271993 3.10381856680104 0.80145161357563 +239.93 13.7556870443462 3.1038196309409 0.804848597812742 +250.45 13.7565868170092 3.10382069431203 0.798926294164389 +250.28 13.757486589982 3.10382175691443 0.806331555144529 +244.48 13.7583863632641 3.10382281874811 0.807730249104792 +252.61 13.7592861368555 3.10382387981305 0.802660208052092 +242.99 13.7601859107558 3.10382494010926 0.805543857715786 +248.97 13.7610856849648 3.10382599963674 0.809340427713657 +238.98 13.7619854594824 3.10382705839548 0.802185278691661 +246.68 13.7628852343083 3.10382811638548 0.799075084850049 +246.12 13.7637850094423 3.10382917360675 0.801822974809732 +261.89 13.7646847848842 3.10383023005927 0.784030804031802 +246.96 13.7655845606336 3.10383128574306 0.795715289629555 +239.32 13.7664843366905 3.10383234065811 0.80189360507101 +228.46 13.7673841130546 3.10383339480441 0.80895895492299 +239.52 13.7682838897256 3.10383444818197 0.802073352705568 +244.38 13.7691836667034 3.10383550079078 0.802402117120174 +267.45 13.7700834439877 3.10383655263085 0.791029950493082 +249.12 13.7709832215782 3.10383760370216 0.804370275191751 +218.79 13.7718829994749 3.10383865400473 0.811618167616705 +218.66 13.7727827776774 3.10383970353855 0.817272008629384 +232.22 13.7736825561854 3.10384075230361 0.822153830064578 +237.48 13.7745823349989 3.10384180029993 0.825754866868431 +238.3 13.7754821141176 3.10384284752748 0.822358118236972 +257.23 13.7763818935412 3.10384389398628 0.809645229557345 +259.29 13.7772816732695 3.10384493967633 0.809160869661642 +241.52 13.7781814533023 3.10384598459761 0.810472200615176 +239.95 13.7790812336394 3.10384702875014 0.805984407509654 +224.06 13.7799810142806 3.1038480721339 0.811358958202058 +227.51 13.7808807952255 3.10384911474891 0.835635571322821 +223.95 13.7817805764741 3.10385015659514 0.823556930624953 +232.35 13.7826803580261 3.10385119767262 0.835402979284383 +245.79 13.7835801398812 3.10385223798133 0.836114333110853 +248.27 13.7844799220392 3.10385327752127 0.821092380797514 +240.01 13.7853797044999 3.10385431629244 0.821718525862004 +230.1 13.7862794872632 3.10385535429484 0.824920408223988 +237.76 13.7871792703286 3.10385639152847 0.818347379637702 +243.98 13.7880790536962 3.10385742799332 0.830815269465236 +247.98 13.7889788373655 3.10385846368941 0.824762665408143 +243.09 13.7898786213364 3.10385949861672 0.805733397423728 +251.19 13.7907784056087 3.10386053277525 0.791611372835246 +252.91 13.7916781901821 3.103861566165 0.788663876004073 +240.89 13.7925779750564 3.10386259878598 0.795639521178795 +237.24 13.7934777602314 3.10386363063817 0.809872789301421 +239.83 13.7943775457069 3.10386466172158 0.803907784554947 +236.04 13.7952773314826 3.10386569203621 0.803508887453032 +228.51 13.7961771175584 3.10386672158206 0.806693815220158 +226.11 13.7970769039339 3.10386775035912 0.814657105359516 +232.93 13.7979766906091 3.10386877836739 0.812079398074053 +237.44 13.7988764775835 3.10386980560688 0.841903245202073 +238.72 13.7997762648571 3.10387083207758 0.815086993918725 +238.32 13.8006760524296 3.10387185777948 0.812235119295825 +236.37 13.7115996633545 3.10286210960506 0.820174489869493 +234.03 13.7124994198059 3.10286321032081 0.807113629708189 +232.43 13.713399176578 3.10286431026812 0.815392025855372 +230.58 13.7142989336705 3.10286540944699 0.812809584601787 +230.19 13.7151986910831 3.10286650785742 0.810150713722059 +227.04 13.7160984488157 3.10286760549941 0.819726591890359 +232.96 13.7169982068681 3.10286870237295 0.817935050459863 +238.41 13.7178979652399 3.10286979847805 0.806076331411061 +239.43 13.718797723931 3.1028708938147 0.815292822973671 +236.64 13.7196974829411 3.1028719883829 0.817059558889186 +235.69 13.7205972422701 3.10287308218266 0.810842702536403 +229.34 13.7214970019177 3.10287417521396 0.811552645622755 +234.21 13.7223967618836 3.10287526747681 0.807060844299434 +242.72 13.7232965221677 3.1028763589712 0.802996998274599 +249.81 13.7241962827698 3.10287744969714 0.801862373737374 +248.45 13.7250960436895 3.10287853965463 0.805099582912654 +240.49 13.7259958049268 3.10287962884366 0.795722010815141 +238.04 13.7268955664813 3.10288071726422 0.80295398672061 +246.71 13.7277953283528 3.10288180491633 0.817935219711925 +246.53 13.7286950905411 3.10288289179998 0.799346240885089 +243.55 13.7295948530461 3.10288397791516 0.797033422470694 +231.77 13.7304946158674 3.10288506326188 0.8105640588226 +239 13.7313943790048 3.10288614784013 0.812928717946729 +238.64 13.7322941424582 3.10288723164991 0.796119705701921 +242.31 13.7331939062272 3.10288831469123 0.791826472342964 +243.66 13.7340936703117 3.10288939696408 0.818706718426012 +240.25 13.7349934347115 3.10289047846845 0.833455241480671 +249.13 13.7358931994263 3.10289155920435 0.817081035644669 +252.09 13.7367929644559 3.10289263917178 0.810234502213574 +242.34 13.7376927298 3.10289371837074 0.811563905694052 +242.02 13.7385924954585 3.10289479680121 0.796201318388983 +236.24 13.7394922614311 3.10289587446322 0.805935144938866 +232.79 13.7403920277177 3.10289695135674 0.793014020585136 +231.22 13.7412917943179 3.10289802748178 0.805353463749912 +236.53 13.7421915612315 3.10289910283833 0.810316389856855 +243.62 13.7430913284584 3.10290017742641 0.80565715390473 +232.93 13.7439910959983 3.102901251246 0.808254385218156 +224.45 13.744890863851 3.10290232429711 0.813645407249045 +233.08 13.7457906320162 3.10290339657972 0.818178305058546 +240.75 13.7466904004938 3.10290446809385 0.809099234261442 +231.9 13.7475901692835 3.10290553883949 0.813937339320337 +241.15 13.7484899383851 3.10290660881664 0.813550033663707 +242.43 13.7493897077983 3.1029076780253 0.804417763656829 +241.64 13.750289477523 3.10290874646546 0.807069893746349 +242.75 13.7511892475588 3.10290981413713 0.800887680943469 +245.74 13.7520890179057 3.1029108810403 0.79275128998968 +244.51 13.7529887885633 3.10291194717498 0.806594126481961 +247.85 13.7538885595315 3.10291301254115 0.811544881764015 +249.99 13.75478833081 3.10291407713883 0.796839524486474 +247.45 13.7556881023986 3.102915140968 0.809187853818334 +255.02 13.7565878742971 3.10291620402867 0.799446619189108 +247.8 13.7574876465052 3.10291726632084 0.794065855292889 +245.7 13.7583874190227 3.1029183278445 0.80056197920031 +249.06 13.7592871918495 3.10291938859965 0.806234963127826 +241.54 13.7601869649852 3.1029204485863 0.806492464525061 +243.79 13.7610867384296 3.10292150780444 0.818736085717611 +242.79 13.7619865121826 3.10292256625406 0.807737740150046 +233.15 13.7628862862439 3.10292362393518 0.81120712549284 +243.5 13.7637860606133 3.10292468084778 0.792619296081966 +242.86 13.7646858352905 3.10292573699186 0.794081227301814 +255.88 13.7655856102754 3.10292679236743 0.800213325859143 +254.3 13.7664853855676 3.10292784697448 0.798285561210822 +249.27 13.7673851611671 3.10292890081302 0.792456082745034 +247.82 13.7682849370735 3.10292995388303 0.802246035674137 +254.72 13.7691847132866 3.10293100618453 0.796454815817218 +262.39 13.7700844898063 3.1029320577175 0.798267157866012 +251.59 13.7709842666322 3.10293310848194 0.797937184955409 +238.72 13.7718840437642 3.10293415847787 0.811350875690156 +227.85 13.7727838212021 3.10293520770526 0.822987923317287 +245.12 13.7736835989455 3.10293625616413 0.814263206848769 +246.98 13.7745833769944 3.10293730385447 0.819108280254777 +247.09 13.7754831553484 3.10293835077628 0.81995825442477 +258.7 13.7763829340074 3.10293939692956 0.813530306640518 +244.58 13.7772827129711 3.1029404423143 0.810519291057516 +238.3 13.7781824922392 3.10294148693051 0.812806865044871 +239.38 13.7790822718117 3.10294253077819 0.813915977387218 +233.46 13.7799820516882 3.10294357385732 0.80485025492116 +231.06 13.7808818318685 3.10294461616792 0.830887029437368 +235.86 13.7817816123525 3.10294565770999 0.841095668272512 +236.64 13.7826813931398 3.10294669848351 0.831310332656843 +237.07 13.7835811742302 3.10294773848849 0.814423988919887 +242.7 13.7844809556236 3.10294877772492 0.819129204766063 +245.87 13.7853807373197 3.10294981619281 0.81773768565294 +240.2 13.7862805193183 3.10295085389216 0.821844353226284 +235.79 13.7871803016191 3.10295189082296 0.811553462595004 +239.94 13.788080084222 3.10295292698521 0.814401050720439 +244.36 13.7889798671267 3.10295396237891 0.831741707159509 +238.82 13.7898796503329 3.10295499700406 0.808962683790822 +246.13 13.7907794338405 3.10295603086066 0.805332167832168 +241.75 13.7916792176493 3.10295706394871 0.799953801894122 +242.37 13.792579001759 3.1029580962682 0.801610428825377 +242.51 13.7934787861693 3.10295912781913 0.806792285031405 +237.02 13.7943785708802 3.10296015860151 0.809257816756737 +239.23 13.7952783558912 3.10296118861533 0.79749375927815 +235.49 13.7961781412023 3.10296221786059 0.807520343749222 +236.24 13.7970779268132 3.10296324633729 0.830300315035664 +234.03 13.7979777127236 3.10296427404543 0.824168758243003 +233.76 13.7988774989334 3.102965300985 0.822692812363318 +234.05 13.7997772854423 3.10296632715601 0.816215428733543 +245.9 13.8006770722502 3.10296735255845 0.794005140763828 +229.51 13.7116007585501 3.10195763510381 0.819552814186584 +229.23 13.7125005142373 3.10195873549811 0.808602364160127 +234.1 13.713400270245 3.10195983512419 0.8055861815509 +229.45 13.7143000265732 3.10196093398205 0.815619104281319 +235.86 13.7151997832215 3.1019620320717 0.794895040655951 +241.95 13.7160995401898 3.10196312939312 0.799570046299716 +236.75 13.7169992974778 3.10196422594633 0.811976206625036 +238.63 13.7178990550853 3.10196532173132 0.813328034909614 +238.84 13.718798813012 3.10196641674808 0.808188828767415 +231.1 13.7196985712579 3.10196751099662 0.799667525838112 +233.77 13.7205983298225 3.10196860447694 0.813199192652512 +225.49 13.7214980887058 3.10196969718902 0.817613269160522 +230.68 13.7223978479074 3.10197078913288 0.820849300678896 +234.93 13.7232976074272 3.10197188030851 0.811857701279869 +238.76 13.7241973672649 3.10197297071592 0.807189478659287 +244.87 13.7250971274203 3.10197406035508 0.800259045939317 +240.15 13.7259968878932 3.10197514922602 0.801161410478272 +243.54 13.7268966486833 3.10197623732872 0.811657791026113 +245.41 13.7277964097905 3.10197732466318 0.813504610118336 +240.24 13.7286961712145 3.10197841122941 0.787739325688624 +229.95 13.7295959329551 3.1019794970274 0.813507163369117 +229.05 13.7304956950121 3.10198058205715 0.815326105554605 +237.44 13.7313954573852 3.10198166631865 0.803107622787055 +235.47 13.7322952200742 3.10198274981192 0.801454762284001 +242.43 13.7331949830789 3.10198383253694 0.814822795155658 +236.9 13.7340947463991 3.10198491449371 0.822166133785638 +248.8 13.7349945100345 3.10198599568224 0.813177222398911 +241.24 13.7358942739849 3.10198707610252 0.802064166405036 +248.2 13.7367940382501 3.10198815575455 0.807562358609748 +238.55 13.7376938028299 3.10198923463833 0.822787271273953 +243.82 13.7385935677241 3.10199031275386 0.808625638925485 +244.34 13.7394933329324 3.10199139010113 0.802670847492698 +241.81 13.7403930984545 3.10199246668016 0.794212758808954 +241.85 13.7412928642904 3.10199354249092 0.805674898413031 +235 13.7421926304397 3.10199461753343 0.810447205772902 +234.77 13.7430923969022 3.10199569180767 0.804407284876675 +232.28 13.7439921636777 3.10199676531366 0.802205605738464 +225.33 13.7448919307661 3.10199783805139 0.811334818512253 +236.29 13.7457916981669 3.10199891002085 0.809198911211098 +236.64 13.7466914658801 3.10199998122205 0.817410658043926 +239.6 13.7475912339054 3.10200105165499 0.820686087726264 +233.72 13.7484910022426 3.10200212131965 0.817821091585453 +237.9 13.7493907708915 3.10200319021606 0.814020085041929 +243.16 13.7502905398518 3.10200425834419 0.805204952284698 +247.3 13.7511903091233 3.10200532570405 0.800886600438996 +241.29 13.7520900787058 3.10200639229564 0.804476795052594 +247.29 13.752989848599 3.10200745811895 0.801987580627703 +244.36 13.7538896188028 3.10200852317399 0.808336313179211 +246.32 13.754789389317 3.10200958746076 0.812770749307686 +243.78 13.7556891601412 3.10201065097924 0.800003271127394 +247.35 13.7565889312753 3.10201171372945 0.807154764413957 +236.68 13.757488702719 3.10201277571138 0.801128863767036 +256.03 13.7583884744721 3.10201383692503 0.785839877159065 +249.54 13.7592882465345 3.1020148973704 0.797826842212452 +236.89 13.7601880189058 3.10201595704748 0.800128001321304 +238.14 13.7610877915859 3.10201701595628 0.806564912678245 +246.36 13.7619875645745 3.10201807409679 0.801129080863888 +235.75 13.7628873378714 3.10201913146902 0.804304013526671 +243.32 13.7637871114764 3.10202018807295 0.792461923239911 +252.08 13.7646868853892 3.10202124390859 0.795697963561898 +265.34 13.7655866596097 3.10202229897595 0.78574399605862 +255.67 13.7664864341375 3.10202335327501 0.787325413388987 +242.82 13.7673862089726 3.10202440680577 0.799265831509935 +247.49 13.7682859841146 3.10202545956825 0.794605652844461 +261.33 13.7691857595633 3.10202651156242 0.79008395399228 +258.85 13.7700855353186 3.1020275627883 0.804281391209603 +256.43 13.7709853113801 3.10202861324587 0.799521431543903 +237.65 13.7718850877477 3.10202966293515 0.816245628266842 +240.13 13.7727848644212 3.10203071185612 0.817855002995806 +249.73 13.7736846414002 3.1020317600088 0.807743953612573 +242.78 13.7745844186847 3.10203280739316 0.820341125370332 +249.34 13.7754841962743 3.10203385400922 0.815856436468693 +252.49 13.7763839741688 3.10203489985698 0.80053243659801 +242.26 13.7772837523681 3.10203594493642 0.8153103104238 +236.67 13.7781835308719 3.10203698924756 0.813985118809505 +241.94 13.7790833096799 3.10203803279039 0.818831270323537 +232.68 13.779983088792 3.1020390755649 0.811055625085191 +230.15 13.7808828682079 3.1020401175711 0.816929163698101 +237.91 13.7817826479274 3.10204115880898 0.821210861998635 +238.16 13.7826824279503 3.10204219927855 0.811402972114227 +238.23 13.7835822082764 3.1020432389798 0.807469463503782 +238.72 13.7844819889053 3.10204427791274 0.821960909893171 +240.28 13.785381769837 3.10204531607735 0.822697745510126 +232.28 13.7862815510712 3.10204635347364 0.817912938847594 +232.41 13.7871813326076 3.10204739010161 0.813516231545919 +232.47 13.788081114446 3.10204842596126 0.816746739876459 +242.38 13.7889808965862 3.10204946105258 0.832555522340818 +243.81 13.7898806790281 3.10205049537557 0.807530979985233 +241.83 13.7907804617713 3.10205152893024 0.805450073782587 +236.86 13.7916802448156 3.10205256171657 0.799252046876171 +228.91 13.7925800281608 3.10205359373458 0.816203278950098 +233.85 13.7934798118068 3.10205462498426 0.805788889851092 +233.79 13.7943795957531 3.1020556554656 0.805540856420235 +239.92 13.7952793799998 3.10205668517861 0.798980411894112 +241.8 13.7961791645464 3.10205771412329 0.813289026462734 +239.48 13.7970789493929 3.10205874229962 0.831428415181013 +230.14 13.7979787345389 3.10205976970762 0.808503278353433 +243.49 13.7988785199842 3.10206079634729 0.80011031019989 +232.8 13.7997783057287 3.10206182221861 0.812685508576605 +238.72 13.8006780917721 3.10206284732159 0.811624125839879 +225.51 13.7116018534249 3.10105316058669 0.824679605656775 +226.5 13.712501608348 3.10105426065953 0.816267212654061 +233.46 13.7134013635916 3.10105535996438 0.812906684195905 +230.25 13.7143011191557 3.10105645850123 0.814563559861314 +236.44 13.7152008750399 3.10105755627009 0.799934236380114 +234.81 13.7161006312441 3.10105865327096 0.802079563822344 +244.94 13.717000387768 3.10105974950383 0.808156325866972 +240.51 13.7179001446114 3.10106084496871 0.81141407207091 +237.67 13.7187999017741 3.10106193966558 0.80280289366606 +235.22 13.7196996592558 3.10106303359446 0.808705358013995 +233.56 13.7205994170563 3.10106412675534 0.809514034997691 +235 13.7214991751755 3.10106521914821 0.806444837586538 +235.75 13.722398933613 3.10106631077309 0.802108443681273 +231.93 13.7232986923687 3.10106740162995 0.808331510157117 +234.66 13.7241984514423 3.10106849171881 0.817516313372678 +239.41 13.7250982108336 3.10106958103966 0.814286486611729 +235.34 13.7259979705423 3.10107066959251 0.809041306297069 +242.1 13.7268977305684 3.10107175737734 0.812818921006011 +241.5 13.7277974909115 3.10107284439416 0.816748247122635 +239.43 13.7286972515714 3.10107393064297 0.797091455380561 +234.07 13.7295970125478 3.10107501612377 0.811168635173251 +247 13.7304967738407 3.10107610083655 0.811367309516756 +244.38 13.7313965354496 3.10107718478131 0.797698461637023 +245.27 13.7322962973745 3.10107826795805 0.811677610163501 +243.81 13.7331960596151 3.10107935036678 0.812200854141991 +239.63 13.7340958221712 3.10108043200748 0.822034296113613 +244.68 13.7349955850424 3.10108151288016 0.816334473798342 +234.04 13.7358953482287 3.10108259298482 0.809319031248355 +239.95 13.7367951117298 3.10108367232145 0.809655418702958 +242.59 13.7376948755455 3.10108475089006 0.81842139939386 +239.04 13.7385946396755 3.10108582869064 0.822844143706848 +245.28 13.7394944041197 3.10108690572319 0.793244364455929 +244.38 13.7403941688777 3.10108798198771 0.811066399898088 +239.38 13.7412939339494 3.1010890574842 0.795827711468604 +238.77 13.7421936993346 3.10109013221265 0.808565549607799 +241.51 13.743093465033 3.10109120617307 0.804067905188982 +233 13.7439932310444 3.10109227936546 0.80586843427386 +240.46 13.7448929973685 3.10109335178981 0.797412768563245 +243.25 13.7457927640053 3.10109442344612 0.801681523666343 +239.19 13.7466925309543 3.10109549433439 0.801892204151215 +235.7 13.7475922982155 3.10109656445462 0.810997976346807 +238.21 13.7484920657885 3.10109763380681 0.812268306939121 +235.17 13.7493918336733 3.10109870239095 0.81388153813536 +241.41 13.7502916018694 3.10109977020705 0.802598877495597 +241.2 13.7511913703768 3.1011008372551 0.805427599421265 +241.69 13.7520911391951 3.10110190353511 0.80761363458926 +245.86 13.7529909083242 3.10110296904707 0.788911078149471 +249.09 13.7538906777639 3.10110403379097 0.801223253634119 +239.28 13.7547904475138 3.10110509776683 0.816189706196418 +239.58 13.7556902175739 3.10110616097463 0.812504623339005 +236.04 13.7565899879438 3.10110722341438 0.806889835467226 +231.49 13.7574897586234 3.10110828508607 0.804403937114841 +251.67 13.7583895296124 3.10110934598971 0.796811434854316 +237.11 13.7592893009106 3.10111040612529 0.801588856415198 +234.18 13.7601890725177 3.10111146549281 0.794779136763368 +240.62 13.7610888444336 3.10111252409227 0.808391326512466 +241.42 13.761988616658 3.10111358192367 0.798885068378912 +241.74 13.7628883891908 3.101114638987 0.807337079377382 +252.65 13.7637881620316 3.10111569528227 0.795630184098725 +246.39 13.7646879351803 3.10111675080948 0.797367797980128 +247.3 13.7655877086365 3.10111780556861 0.793692952115258 +239.12 13.7664874824002 3.10111885955968 0.811508478175145 +234.11 13.7673872564711 3.10111991278268 0.811851968752466 +251.06 13.768287030849 3.10112096523761 0.796811184417216 +256.37 13.7691868055335 3.10112201692447 0.792043992043992 +257.9 13.7700865805246 3.10112306784325 0.795366539926914 +249.03 13.770986355822 3.10112411799396 0.793106147788033 +245.74 13.7718861314254 3.10112516737659 0.806680925529846 +242.24 13.7727859073346 3.10112621599114 0.808441891281319 +244.86 13.7736856835495 3.10112726383762 0.788868700791513 +236.29 13.7745854600698 3.10112831091601 0.813891681399568 +242.67 13.7754852368952 3.10112935722633 0.812519701384671 +234.66 13.7763850140256 3.10113040276856 0.804840089003814 +237.72 13.7772847914607 3.1011314475427 0.81094899812048 +229.68 13.7781845692002 3.10113249154877 0.80873168835251 +241.19 13.7790843472441 3.10113353478674 0.813169231729779 +235.05 13.779984125592 3.10113457725663 0.820324789312501 +232.4 13.7808839042437 3.10113561895843 0.822148609286653 +242.57 13.781783683199 3.10113665989214 0.80610643804594 +240.37 13.7826834624577 3.10113770005776 0.813568784273355 +235.15 13.7835832420196 3.10113873945528 0.809822157754239 +240.76 13.7844830218843 3.10113977808471 0.816084116982361 +238.72 13.7853828020518 3.10114081594604 0.819455432981534 +226.34 13.7862825825218 3.10114185303928 0.817271799125802 +228 13.787182363294 3.10114288936442 0.821368551225545 +229.69 13.7880821443682 3.10114392492146 0.808143263554291 +233.96 13.7889819257442 3.1011449597104 0.816487032939041 +246.06 13.7898817074219 3.10114599373124 0.844626013234747 +243.87 13.7907814894009 3.10114702698397 0.833609195245392 +244.07 13.791681271681 3.10114805946861 0.82297727381184 +233.67 13.792581054262 3.10114909118513 0.824987182966917 +235.94 13.7934808371437 3.10115012213355 0.822012372329308 +231.8 13.7943806203259 3.10115115231386 0.830957338507433 +239.9 13.7952804038083 3.10115218172606 0.836353584372505 +241.73 13.7961801875907 3.10115321037015 0.828853450051134 +230.29 13.797079971673 3.10115423824613 0.827956203579557 +230.14 13.7979797560548 3.10115526535399 0.812423921307549 +231.75 13.7988795407359 3.10115629169374 0.809136769101622 +235.95 13.7997793257161 3.10115731726537 0.817933645286206 +240.87 13.8006791109953 3.10115834206889 0.817939084881784 +236.15 13.7116029479789 3.1001486860537 0.837356133517554 +235.68 13.7125027021381 3.10014978580508 0.823944595888897 +229.64 13.7134024566179 3.10015088478869 0.812700443938891 +222.77 13.7143022114181 3.10015198300454 0.81252530209164 +220.85 13.7152019665384 3.10015308045261 0.801079374777252 +242.24 13.7161017219787 3.10015417713292 0.797373695540908 +245.91 13.7170014777387 3.10015527304546 0.803638713264436 +238.96 13.7179012338183 3.10015636819023 0.814966433185433 +235.12 13.718800990217 3.10015746256722 0.813227090437764 +243.42 13.7197007469349 3.10015855617643 0.807229098640747 +234.05 13.7206005039715 3.10015964901787 0.813477737665463 +234.34 13.7215002613268 3.10016074109153 0.818306073869308 +235.64 13.7224000190004 3.10016183239742 0.811724010130335 +237.55 13.7232997769922 3.10016292293552 0.806245589695136 +232.36 13.7241995353019 3.10016401270584 0.802571050219008 +240.06 13.7250992939294 3.10016510170838 0.813964273902614 +238.12 13.7259990528743 3.10016618994313 0.808851013529703 +239.07 13.7268988121364 3.1001672774101 0.817559742733737 +236.06 13.7277985717156 3.10016836410928 0.819756123326744 +233.31 13.7286983316116 3.10016945004067 0.807618119345895 +235.87 13.7295980918242 3.10017053520427 0.807737587788739 +237.58 13.7304978523531 3.10017161960008 0.813231373487096 +247.05 13.7313976131982 3.1001727032281 0.80639982177906 +238.68 13.7322973743592 3.10017378608833 0.810477211712311 +250.79 13.7331971358359 3.10017486818076 0.809991851887037 +241.5 13.734096897628 3.10017594950539 0.805963015201379 +239.54 13.7349966597354 3.10017703006222 0.811697889962532 +236.72 13.7358964221578 3.10017810985126 0.803437367774173 +237.33 13.736796184895 3.10017918887249 0.813728125071989 +241.96 13.7376959479467 3.10018026712593 0.811770382181211 +240.63 13.7385957113129 3.10018134461156 0.810942022579021 +239.52 13.7394954749931 3.10018242132938 0.8306441312955 +239.1 13.7403952389872 3.1001834972794 0.804616481613528 +238.68 13.741295003295 3.10018457246162 0.813652831089431 +238.3 13.7421947679163 3.10018564687602 0.811449707149616 +240.7 13.7430945328507 3.10018672052262 0.811176191714203 +236.39 13.7439942980982 3.1001877934014 0.810315023003352 +231.02 13.7448940636585 3.10018886551237 0.805934215958373 +227.99 13.7457938295313 3.10018993685553 0.817944010652631 +231.03 13.7466935957164 3.10019100743087 0.807163967176846 +224.74 13.7475933622137 3.10019207723839 0.824299331341585 +231.33 13.7484931290228 3.1001931462781 0.820166621004742 +235.19 13.7493928961436 3.10019421454999 0.820946900020608 +244.47 13.7502926635758 3.10019528205406 0.809577539316312 +241.73 13.7511924313192 3.10019634879031 0.808310389715115 +242.19 13.7520921993737 3.10019741475873 0.806788842101101 +243.87 13.7529919677388 3.10019847995933 0.810381679389313 +240.41 13.7538917364146 3.1001995443921 0.817450871485625 +249.74 13.7547915054006 3.10020060805705 0.806666896797726 +245.39 13.7556912746967 3.10020167095417 0.801287684915967 +239.68 13.7565910443027 3.10020273308346 0.798008860823955 +239.17 13.7574908142183 3.10020379444492 0.809666789849717 +235 13.7583905844434 3.10020485503854 0.797099787929157 +231.74 13.7592903549776 3.10020591486433 0.793976027046409 +242.69 13.7601901258209 3.10020697392229 0.8025020368072 +239.56 13.7610898969728 3.10020803221241 0.804195748856496 +240.59 13.7619896684333 3.1002090897347 0.803880972678927 +239.93 13.7628894402021 3.10021014648914 0.800132455234655 +249.2 13.763789212279 3.10021120247575 0.801087431043378 +237.85 13.7646889846637 3.10021225769451 0.799611605364493 +243.28 13.765588757356 3.10021331214543 0.804165676724479 +259.88 13.7664885303558 3.10021436582851 0.791319188863454 +253.93 13.7673883036627 3.10021541874374 0.789553501122809 +253.27 13.7682880772766 3.10021647089113 0.7847632379245 +238.82 13.7691878511972 3.10021752227067 0.790805782923078 +249.17 13.7700876254243 3.10021857288236 0.796272018687579 +257.8 13.7709873999577 3.1002196227262 0.789100533726508 +252.01 13.7718871747972 3.10022067180218 0.800775244829442 +259.86 13.7727869499425 3.10022172011032 0.779903686617296 +250.52 13.7736867253934 3.1002227676506 0.789623399406489 +250.1 13.7745865011497 3.10022381442302 0.795776063825509 +245.42 13.7754862772112 3.10022486042759 0.803774227374563 +233.9 13.7763860535776 3.1002259056643 0.816038141388878 +226 13.7772858302487 3.10022695013315 0.815690584517912 +227.57 13.7781856072243 3.10022799383413 0.816863694858084 +242.67 13.7790853845042 3.10022903676726 0.807797328288268 +241.18 13.7799851620882 3.10023007893253 0.814742512506646 +227.03 13.7808849399759 3.10023112032992 0.827872245933353 +239.57 13.7817847181673 3.10023216095946 0.820225490233459 +236.53 13.782684496662 3.10023320082112 0.809344403916299 +238.36 13.7835842754599 3.10023423991492 0.808414427969358 +242.93 13.7844840545607 3.10023527824085 0.815163199083795 +239.72 13.7853838339641 3.10023631579891 0.824501454130809 +230.34 13.7862836136701 3.10023735258909 0.815198082616664 +231.42 13.7871833936783 3.1002383886114 0.820112542399467 +237.27 13.7880831739886 3.10023942386584 0.817812631836265 +240.58 13.7889829546007 3.1002404583524 0.813648293963255 +243.52 13.7898827355143 3.10024149207108 0.83314245501711 +239.28 13.7907825167293 3.10024252502188 0.81036287508723 +237 13.7916822982454 3.10024355720481 0.820772467332365 +237.12 13.7925820800625 3.10024458861985 0.821255321820319 +240.99 13.7934818621802 3.10024561926701 0.808719320836771 +229.78 13.7943816445984 3.10024664914629 0.825380801092669 +227.51 13.7952814273168 3.10024767825768 0.818926796081979 +229.67 13.7961812103353 3.10024870660118 0.816450114182219 +234.92 13.7970809936535 3.1002497341768 0.816048806966308 +233.05 13.7979807772713 3.10025076098453 0.809631184314215 +239.85 13.7988805611884 3.10025178702437 0.805141677917381 +243.76 13.7997803454047 3.10025281229631 0.807315196976146 +247.31 13.8006801299199 3.10025383680037 0.809972989661822 +229.37 13.711604042212 3.09924421150483 0.817433255232308 +235.12 13.7125037956075 3.09924531093475 0.811228737956465 +227.96 13.7134035493237 3.09924640959713 0.815014402692818 +226.51 13.7143033033602 3.09924750749197 0.811446359178857 +227 13.715203057717 3.09924860461927 0.812198818124233 +236.49 13.7161028123936 3.09924970097902 0.813367748223103 +237.92 13.71700256739 3.09925079657122 0.820526682168935 +237.36 13.7179023227058 3.09925189139588 0.829504124266966 +230.53 13.718802078341 3.09925298545298 0.823365195072987 +237.37 13.7197018342952 3.09925407874254 0.809279520064607 +239.55 13.7206015905682 3.09925517126454 0.811140858714141 +225.8 13.7215013471598 3.09925626301899 0.803986163729204 +230.55 13.7224011040697 3.09925735400588 0.81731878695282 +236.07 13.7233008612979 3.09925844422522 0.803511758006583 +236.71 13.7242006188439 3.09925953367701 0.795607459472094 +237.29 13.7251003767077 3.09926062236123 0.804068645061448 +243.7 13.7260001348889 3.09926171027789 0.804156181378128 +235.44 13.7268998933874 3.09926279742699 0.81088205529984 +240.53 13.7277996522029 3.09926388380853 0.814301354076635 +235.38 13.7286994113352 3.09926496942251 0.806607145020413 +234.88 13.7295991707841 3.09926605426892 0.814030122700576 +231.43 13.7304989305494 3.09926713834776 0.80604584265179 +233.84 13.7313986906308 3.09926822165904 0.803758328348357 +232.52 13.7322984510281 3.09926930420274 0.797829237275604 +242.94 13.7331982117411 3.09927038597888 0.81518509732154 +243.33 13.7340979727696 3.09927146698744 0.812392400155099 +240.5 13.7349977341133 3.09927254722843 0.809144231063739 +242.52 13.735897495772 3.09927362670184 0.795068786850098 +239.17 13.7367972577455 3.09927470540768 0.808316612892707 +235.2 13.7376970200336 3.09927578334594 0.802268082020176 +234.79 13.7385967826361 3.09927686051662 0.808085217147548 +245.18 13.7394965455526 3.09927793691972 0.821050787715429 +242.4 13.740396308783 3.09927901255525 0.827251003902494 +244.12 13.7412960723272 3.09928008742318 0.811623110736436 +238.73 13.7421958361847 3.09928116152354 0.81769583081749 +239.78 13.7430956003555 3.09928223485631 0.816735870554319 +233.87 13.7439953648393 3.09928330742149 0.803601146160487 +237 13.7448951296359 3.09928437921908 0.805827653320305 +236.58 13.745794894745 3.09928545024908 0.805087571972147 +238.8 13.7466946601664 3.0992865205115 0.805307484506595 +232.62 13.7475944259 3.09928759000632 0.805493091498082 +230.42 13.7484941919454 3.09928865873355 0.814768113280692 +235.36 13.7493939583025 3.09928972669318 0.816064913574832 +241.91 13.750293724971 3.09929079388522 0.809860836546554 +240.23 13.7511934919507 3.09929186030966 0.815003506932937 +242.82 13.7520932592414 3.0992929259665 0.812942556587627 +239.57 13.7529930268429 3.09929399085575 0.819421129124934 +244.32 13.7538927947549 3.09929505497739 0.813755396127916 +244.76 13.7547925629773 3.09929611833142 0.799569446077378 +245.49 13.7556923315097 3.09929718091786 0.802691595186575 +249.07 13.756592100352 3.09929824273669 0.797951515382708 +228.66 13.7574918695039 3.09929930378791 0.814896905363797 +230.09 13.7583916389652 3.09930036407153 0.817359601766809 +236.54 13.7592914087358 3.09930142358753 0.799959100204499 +234.99 13.7601911788153 3.09930248233593 0.812864325480149 +238.31 13.7610909492035 3.09930354031671 0.804830111788088 +244 13.7619907199003 3.09930459752989 0.794014596745442 +236.76 13.7628904909054 3.09930565397544 0.804900843587831 +235.04 13.7637902622185 3.09930670965338 0.807039149865107 +238.02 13.7646900338395 3.09930776456371 0.798893826840108 +250.69 13.7655898057681 3.09930881870641 0.783495822883622 +249.17 13.7664895780041 3.0993098720815 0.799784339221718 +243.99 13.7673893505473 3.09931092468897 0.794206976455497 +242.47 13.7682891233975 3.09931197652881 0.797272461128098 +243.33 13.7691888965544 3.09931302760103 0.795116962386974 +240.18 13.7700886700178 3.09931407790563 0.796430223780651 +243.12 13.7709884437875 3.0993151274426 0.805641721968292 +240.45 13.7718882178632 3.09931617621194 0.797464868586239 +256.55 13.7727879922448 3.09931722421366 0.780868734533207 +254.15 13.7736877669319 3.09931827144774 0.786780077557729 +252.78 13.7745875419245 3.09931931791419 0.802689647982764 +239.63 13.7754873172222 3.09932036361301 0.811605698643773 +238.5 13.7763870928249 3.0993214085442 0.813861538757972 +227.94 13.7772868687323 3.09932245270775 0.828794763908368 +243.8 13.7781866449442 3.09932349610367 0.804845022574584 +247.94 13.7790864214603 3.09932453873195 0.797192541378588 +236.86 13.7799861982805 3.09932558059259 0.806129592349282 +233.12 13.7808859754045 3.09932662168559 0.82729585519058 +242.29 13.7817857528321 3.09932766201094 0.821874791207323 +230.42 13.7826855305631 3.09932870156866 0.820106401774672 +231.84 13.7835853085972 3.09932974035873 0.8102428692114 +235.13 13.7844850869343 3.09933077838116 0.812748876300967 +239.1 13.785384865574 3.09933181563594 0.819842769352722 +240.14 13.7862846445162 3.09933285212307 0.818893315758619 +230.72 13.7871844237607 3.09933388784255 0.819758735276569 +231.57 13.7880842033072 3.09933492279438 0.825129483686213 +243.9 13.7889839831555 3.09933595697856 0.806050490628424 +245.04 13.7898837633054 3.09933699039509 0.816136209660401 +236.55 13.7907835437566 3.09933802304396 0.804752366557299 +229.83 13.791683324509 3.09933905492518 0.809747249552681 +232.25 13.7925831055623 3.09934008603874 0.813474962779059 +235.7 13.7934828869163 3.09934111638464 0.804417780634615 +236.63 13.7943826685707 3.09934214596289 0.80197956269952 +221.94 13.7952824505253 3.09934317477347 0.822478129324296 +226.61 13.79618223278 3.09934420281639 0.82347157668931 +230.49 13.7970820153345 3.09934523009165 0.823646188227198 +239.83 13.7979817981885 3.09934625659924 0.81565698393316 +246.56 13.7988815813419 3.09934728233917 0.81435690475925 +237.36 13.7997813647944 3.09934830731143 0.818782135101463 +253.44 13.8006811485457 3.09934933151603 0.798157385766832 +233.84 13.7116051361243 3.09833973694009 0.80248130605179 +251.08 13.7125048887564 3.09834083604856 0.801311969839774 +229.57 13.7134046417092 3.09834193438971 0.809016984958253 +235.02 13.7143043949823 3.09834303196354 0.809450469854945 +235.74 13.7152041485756 3.09834412877006 0.805954315547733 +243.42 13.7161039024888 3.09834522480925 0.80635967405723 +239.37 13.7170036567217 3.09834632008112 0.802679049551081 +239.34 13.7179034112742 3.09834741458566 0.822936189844583 +228.32 13.7188031661459 3.09834850832288 0.816726377937524 +233.84 13.7197029213366 3.09834960129278 0.817246291667147 +231.31 13.7206026768462 3.09835069349535 0.81202941899858 +231.71 13.7215024326743 3.09835178493058 0.811536062770345 +236.93 13.7224021888209 3.09835287559849 0.806528622307999 +230.23 13.7233019452856 3.09835396549907 0.809544600084895 +239.55 13.7242017020682 3.09835505463231 0.785978621072041 +235.42 13.7251014591685 3.09835614299822 0.799260140475531 +241.69 13.7260012165863 3.09835723059679 0.792028518335925 +238.13 13.7269009743213 3.09835831742803 0.818135772719598 +240.8 13.7278007323734 3.09835940349193 0.798993096330368 +241.38 13.7287004907423 3.09836048878849 0.802089232140921 +233.55 13.7296002494278 3.09836157331771 0.80740476316035 +231.08 13.7305000084296 3.09836265707958 0.812247274609388 +230.56 13.7313997677475 3.09836374007411 0.81093578874782 +246.01 13.7322995273814 3.0983648223013 0.79885590967875 +238.22 13.733199287331 3.09836590376114 0.806263889110937 +239.1 13.734099047596 3.09836698445363 0.814237272407407 +244.87 13.7349988081762 3.09836806437878 0.811913747653094 +242.53 13.7358985690715 3.09836914353657 0.809405045070011 +234.22 13.7367983302815 3.09837022192701 0.819186627502044 +234.28 13.7376980918062 3.0983712995501 0.806660908423661 +234.24 13.7385978536451 3.09837237640583 0.809659650208324 +241.08 13.7394976157982 3.09837345249421 0.811702462388272 +247.16 13.7403973782652 3.09837452781524 0.821126633292972 +246.09 13.7412971410458 3.0983756023689 0.828652361341245 +242.29 13.7421969041399 3.0983766761552 0.817558170537496 +241.32 13.7430966675473 3.09837774917415 0.819870177356701 +232.77 13.7439964312676 3.09837882142573 0.807637781321992 +226.21 13.7448961953007 3.09837989290994 0.818336333134237 +231.99 13.7457959596463 3.09838096362679 0.815359889794513 +244.55 13.7466957243043 3.09838203357628 0.808296511650265 +237.07 13.7475954892744 3.0983831027584 0.811457795267518 +238.29 13.7484952545563 3.09838417117315 0.803197100209746 +241.51 13.7493950201499 3.09838523882053 0.805529029410585 +240.13 13.750294786055 3.09838630570054 0.810449613263611 +248.08 13.7511945522712 3.09838737181317 0.805206223916166 +240.31 13.7520943187985 3.09838843715843 0.805552699651671 +243.61 13.7529940856365 3.09838950173632 0.804607757363663 +242.95 13.753893852785 3.09839056554683 0.798526711099189 +249.86 13.7547936202438 3.09839162858996 0.807174717517344 +241.71 13.7556933880128 3.09839269086571 0.805574232382416 +241.5 13.7565931560916 3.09839375237408 0.809922817466347 +234.04 13.75749292448 3.09839481311507 0.814001320010437 +231.46 13.7583926931779 3.09839587308867 0.81681209732908 +236.91 13.7592924621849 3.09839693229489 0.808017728427738 +229.9 13.7601922315009 3.09839799073373 0.80912493825951 +230.79 13.7610920011257 3.09839904840518 0.809758158113822 +240 13.761991771059 3.09840010530923 0.794322871076654 +235.54 13.7628915413005 3.0984011614459 0.798709573676911 +228.9 13.7637913118502 3.09840221681518 0.816420415855068 +239.94 13.7646910827077 3.09840327141707 0.807985824456839 +246.24 13.7655908538728 3.09840432525156 0.802358779415156 +267.79 13.7664906253453 3.09840537831866 0.775517918033842 +240.15 13.767390397125 3.09840643061836 0.808138046727021 +238.31 13.7682901692117 3.09840748215066 0.805706741923881 +237.12 13.7691899416051 3.09840853291556 0.801677855002332 +239.1 13.7700897143049 3.09840958291307 0.796946380373041 +243.75 13.7709894873111 3.09841063214317 0.80825467763773 +274.84 13.7718892606233 3.09841168060587 0.777850243178863 +274.45 13.7727890342414 3.09841272830116 0.784715582026735 +265.85 13.7736888081651 3.09841377522905 0.770527362284785 +252.1 13.7745885823941 3.09841482138954 0.793105078788404 +241.91 13.7754883569283 3.09841586678261 0.808272819843445 +240.64 13.7763881317675 3.09841691140828 0.818795096135135 +251.47 13.7772879069114 3.09841795526653 0.805163012808288 +249.36 13.7781876823597 3.09841899835738 0.803835407064218 +241.29 13.7790874581124 3.09842004068081 0.807050781095823 +237.76 13.779987234169 3.09842108223682 0.818988512220273 +243.68 13.7808870105295 3.09842212302542 0.817249221973597 +251.43 13.7817867871936 3.09842316304661 0.806092799238896 +229.71 13.782686564161 3.09842420230037 0.821417706114998 +223.33 13.7835863414316 3.09842524078672 0.81703082517116 +227.83 13.7844861190052 3.09842627850564 0.825535313933791 +228.68 13.7853858968814 3.09842731545714 0.819778830470512 +237.75 13.7862856750601 3.09842835164122 0.822715562964086 +237.15 13.787185453541 3.09842938705788 0.818145183164519 +234.7 13.788085232324 3.0984304217071 0.810678936036088 +241.95 13.7889850114088 3.09843145558891 0.808715561074863 +248.43 13.7898847907951 3.09843248870328 0.81149918424074 +234.88 13.7907845704828 3.09843352105022 0.806987937249532 +232.97 13.7916843504717 3.09843455262973 0.809829549172283 +239.23 13.7925841307614 3.09843558344181 0.8009977827051 +229.54 13.7934839113518 3.09843661348646 0.806277191318743 +224.64 13.7943836922427 3.09843764276367 0.81113986589813 +223.65 13.7952834734338 3.09843867127344 0.821415414520971 +225.34 13.796183254925 3.09843969901578 0.820007666384501 +230.79 13.7970830367159 3.09844072599068 0.814021877878137 +245.22 13.7979828188064 3.09844175219814 0.800459952869027 +240.52 13.7988826011962 3.09844277763816 0.815282427659754 +246.46 13.7997823838851 3.09844380231073 0.80357051832508 +245.12 13.800682166873 3.09844482621587 0.814546186783585 +240.94 13.7116062297158 3.0974352623595 0.797719955581475 +249.46 13.7125059815847 3.09743636114651 0.795487325845455 +239.49 13.7134057337742 3.09743745916643 0.809817988828095 +237.41 13.7143054862841 3.09743855641925 0.815213889117843 +243.77 13.7152052391142 3.09743965290498 0.806832813964297 +244.53 13.7161049922642 3.09744074862362 0.801708117818317 +243.05 13.717004745734 3.09744184357515 0.81001318515728 +243.09 13.7179044995232 3.09744293775959 0.820828399795779 +231.7 13.7188042536317 3.09744403117693 0.814333704849065 +233.26 13.7197040080592 3.09744512382716 0.811617490111128 +240.28 13.7206037628056 3.09744621571029 0.814854739254323 +233.25 13.7215035178706 3.09744730682632 0.814107745708716 +233.5 13.7224032732539 3.09744839717524 0.811486821303004 +233.6 13.7233030289554 3.09744948675706 0.8085611180892 +235.88 13.7242027849748 3.09745057557176 0.797521448999047 +239.81 13.7251025413119 3.09745166361936 0.807790762381747 +236.27 13.7260022979664 3.09745275089984 0.807141268782363 +233.04 13.7269020549383 3.09745383741321 0.803642465417042 +241.12 13.7278018122271 3.09745492315947 0.811627807286572 +239.68 13.7287015698328 3.09745600813862 0.805577809329663 +232.8 13.729601327755 3.09745709235064 0.796057319973555 +232 13.7305010859936 3.09745817579555 0.811731250075739 +243.33 13.7314008445484 3.09745925847334 0.804547286946706 +242.31 13.732300603419 3.09746034038401 0.795408032744948 +239.04 13.7332003626053 3.09746142152756 0.79903631927728 +241.3 13.7341001221071 3.09746250190398 0.815763465656399 +247.15 13.7349998819241 3.09746358151328 0.814461281916107 +239.02 13.7358996420562 3.09746466035545 0.81104885744335 +231.25 13.736799402503 3.0974657384305 0.815955655346618 +223.07 13.7376991632644 3.09746681573841 0.807351434426229 +240.35 13.7385989243401 3.0974678922792 0.803217711938938 +237.4 13.7394986857299 3.09746896805286 0.813279075750134 +238.63 13.7403984474337 3.09747004305938 0.814569690936523 +250.95 13.7412982094511 3.09747111729877 0.797302577826195 +241.93 13.742197971782 3.09747219077102 0.818118519073111 +238.58 13.743097734426 3.09747326347614 0.812987350380329 +232.73 13.7439974973831 3.09747433541412 0.823738582233845 +234.59 13.744897260653 3.09747540658496 0.814314593837755 +233.12 13.7457970242354 3.09747647698866 0.821289785697381 +243.06 13.7466967881301 3.09747754662522 0.81019551139073 +244.51 13.7475965523369 3.09747861549464 0.800994633076472 +241.53 13.7484963168556 3.09747968359691 0.797178550182714 +236.73 13.749396081686 3.09748075093203 0.809549876631662 +239.67 13.7502958468278 3.09748181750001 0.81395239989703 +244.16 13.7511956122808 3.09748288330084 0.792863293319151 +234.84 13.7520953780447 3.09748394833452 0.813346844582372 +243.98 13.7529951441195 3.09748501260105 0.814725457570715 +243.72 13.7538949105047 3.09748607610043 0.802328851428735 +247.87 13.7547946772003 3.09748713883265 0.797723547471856 +245.31 13.755694444206 3.09748820079772 0.798670396043618 +246.08 13.7565942115215 3.09748926199563 0.813863447439171 +233.5 13.7574939791467 3.09749032242639 0.807798327060139 +229.87 13.7583937470813 3.09749138208998 0.80754171831009 +231 13.7592935153251 3.09749244098642 0.810337376356594 +232.84 13.7601932838778 3.09749349911569 0.812770283417852 +224.46 13.7610930527393 3.0974945564778 0.820266158040735 +224.46 13.7619928219093 3.09749561307275 0.804622337420663 +235.09 13.7628925913876 3.09749666890053 0.798924645830809 +246.29 13.763792361174 3.09749772396115 0.800998721636306 +252.76 13.7646921312682 3.09749877825459 0.804108363317913 +247.23 13.7655919016701 3.09749983178087 0.794856032850574 +260.46 13.7664916723793 3.09750088453998 0.779196083504803 +259.96 13.7673914433957 3.09750193653191 0.770306623211992 +236.46 13.7682912147191 3.09750298775668 0.80335910423887 +242.83 13.7691909863492 3.09750403821426 0.812408487781934 +245.56 13.7700907582858 3.09750508790468 0.787036082367934 +254.24 13.7709905305287 3.09750613682791 0.798367402770346 +262.16 13.7718903030777 3.09750718498397 0.7891953125 +265.04 13.7727900759324 3.09750823237284 0.791501884693815 +249.05 13.7736898490928 3.09750927899454 0.80618792502648 +242.33 13.7745896225586 3.09751032484905 0.805398389653993 +242.18 13.7754893963295 3.09751136993638 0.815366506559338 +247.63 13.7763891704054 3.09751241425653 0.807235180219857 +254.45 13.777288944786 3.09751345780949 0.804818450557117 +244.68 13.778188719471 3.09751450059526 0.808598478471738 +218.6 13.7790884944604 3.09751554261384 0.820471358693455 +225.28 13.7799882697537 3.09751658386523 0.819779692529138 +255.24 13.7808880453509 3.09751762434943 0.807371425747918 +255.98 13.7817878212517 3.09751866406644 0.812138771265136 +236.29 13.7826875974559 3.09751970301626 0.812116374446065 +218.63 13.7835873739632 3.09752074119888 0.820768206093343 +233.77 13.7844871507734 3.0975217786143 0.827280901483619 +224.83 13.7853869278863 3.09752281526253 0.818003945538631 +229.37 13.7862867053017 3.09752385114356 0.825924045178962 +233.92 13.7871864830193 3.09752488625738 0.819900995167903 +236.37 13.788086261039 3.09752592060401 0.812410046421115 +250 13.7889860393604 3.09752695418343 0.834138842311839 +249.13 13.7898858179835 3.09752798699565 0.799192037842471 +245.33 13.7907855969079 3.09752901904066 0.808201306209181 +238.63 13.7916853761334 3.09753005031847 0.812627775400561 +243.59 13.7925851556598 3.09753108082907 0.800477964096744 +229.74 13.7934849354869 3.09753211057246 0.805938349568345 +223.23 13.7943847156145 3.09753313954864 0.815406244413022 +223.41 13.7952844960423 3.0975341677576 0.820840154514883 +228.04 13.7961842767701 3.09753519519936 0.815836182353151 +234.11 13.7970840577977 3.0975362218739 0.805629976697529 +253.44 13.7979838391249 3.09753724778122 0.801251090614483 +255.02 13.7988836207514 3.09753827292133 0.797007667566043 +232.39 13.799783402677 3.09753929729422 0.805751574474543 +235.96 13.8006831849015 3.09754032089989 0.805877878315395 +246.1 13.7116073229864 3.09653078776304 0.7933289425996 +247.18 13.7125070740923 3.0965318862286 0.801280128012801 +242.38 13.7134068255189 3.09653298392729 0.804347236587756 +229.67 13.7143065772658 3.09653408085911 0.811103824964955 +239.41 13.7152063293329 3.09653517702406 0.803914491622172 +252.96 13.71610608172 3.09653627242213 0.800852222072624 +246.75 13.7170058344267 3.09653736705334 0.817271201941426 +240.75 13.717905587453 3.09653846091767 0.812433661865049 +236.09 13.7188053407985 3.09653955401512 0.815027554526385 +241.04 13.7197050944631 3.09654064634569 0.799348460929749 +238.94 13.7206048484464 3.09654173790939 0.818592701494927 +233.1 13.7215046027484 3.09654282870621 0.817691002867963 +242.39 13.7224043573687 3.09654391873614 0.802629453503902 +238.37 13.7233041123072 3.09654500799919 0.812124666100637 +241.92 13.7242038675636 3.09654609649536 0.800477461691343 +237.4 13.7251036231377 3.09654718422465 0.811221597438215 +231.45 13.7260033790293 3.09654827118704 0.815230288836846 +234.46 13.7269031352382 3.09654935738255 0.817327244495821 +240.6 13.727802891764 3.09655044281117 0.80844816953741 +234.6 13.7287026486067 3.09655152747289 0.800186508134752 +233.5 13.7296024057659 3.09655261136773 0.798893113645965 +237.58 13.7305021632415 3.09655369449567 0.79875599112365 +242.48 13.7314019210333 3.09655477685672 0.802911190995344 +241.26 13.7323016791409 3.09655585845087 0.803456766664291 +247.23 13.7332014375642 3.09655693927812 0.801235131784493 +249.81 13.734101196303 3.09655801933848 0.811040205868284 +248.9 13.735000955357 3.09655909863193 0.8068055185559 +235.57 13.735900714726 3.09656017715849 0.807047578286611 +231.39 13.7368004744098 3.09656125491814 0.813095632477908 +237.21 13.7377002344082 3.09656233191088 0.81512466418438 +242.15 13.7385999947209 3.09656340813672 0.809182812162613 +231.46 13.7394997553478 3.09656448359566 0.818558285817366 +241.44 13.7403995162885 3.09656555828768 0.802774474179119 +253.78 13.7412992775429 3.0965666322128 0.803817914831131 +249.03 13.7421990391107 3.09656770537101 0.815906757381895 +239.03 13.7430988009918 3.0965687777623 0.80042689434365 +235.27 13.7439985631858 3.09656984938668 0.824142825741121 +242.41 13.7448983256927 3.09657092024415 0.833531215823464 +246.33 13.7457980885121 3.09657199033469 0.835809351078868 +250.22 13.7466978516438 3.09657305965833 0.794189224311063 +240.63 13.7475976150876 3.09657412821504 0.795476186498722 +243.56 13.7484973788432 3.09657519600483 0.802774703031678 +237.86 13.7493971429106 3.0965762630277 0.812437105390966 +237.69 13.7502969072893 3.09657732928365 0.799452182334335 +241.84 13.7511966719793 3.09657839477268 0.804315746370709 +239.01 13.7520964369802 3.09657945949478 0.807039458600489 +239.75 13.752996202292 3.09658052344995 0.81143363702752 +243.04 13.7538959679142 3.0965815866382 0.809424042840112 +244.37 13.7547957338467 3.09658264905952 0.797507217918743 +249.24 13.7556955000894 3.0965837107139 0.803591247819883 +245.63 13.7565952666419 3.09658477160135 0.810469327393289 +226.2 13.757495033504 3.09658583172188 0.820212107137328 +224.49 13.7583948006756 3.09658689107546 0.810579187715022 +237.46 13.7592945681563 3.09658794966211 0.79831832071741 +229.19 13.760194335946 3.09658900748183 0.808393498566798 +223.86 13.7610941040444 3.0965900645346 0.814328626122393 +242.15 13.7619938724514 3.09659112082044 0.796726273127186 +249.45 13.7628936411667 3.09659217633933 0.803354526475612 +256.05 13.76379341019 3.09659323109128 0.79617748736245 +247.3 13.7646931795212 3.09659428507629 0.796403014631736 +251.76 13.76559294916 3.09659533829436 0.789506302081152 +248.32 13.7664927191062 3.09659639074548 0.80669061777656 +238.85 13.7673924893595 3.09659744242965 0.796416567688459 +240.38 13.7682922599198 3.09659849334687 0.788670005186325 +243.57 13.7691920307869 3.09659954349714 0.793362117483701 +241.16 13.7700918019604 3.09660059288046 0.783873133503871 +243.93 13.7709915734403 3.09660164149683 0.785024184988946 +243.3 13.7718913452261 3.09660268934624 0.797494798379284 +252.84 13.7727911173179 3.0966037364287 0.808387399240809 +249.6 13.7736908897152 3.0966047827442 0.797884706691334 +247.58 13.7745906624179 3.09660582829275 0.815331402589997 +258.96 13.7754904354258 3.09660687307433 0.803769194797492 +254.2 13.7763902087385 3.09660791708896 0.807595090441238 +244.89 13.7772899823561 3.09660896033662 0.812653593363613 +251.33 13.7781897562781 3.09661000281732 0.800751296881522 +230.61 13.7790895305043 3.09661104453105 0.815414178177836 +222.9 13.7799893050346 3.09661208547782 0.821317494002948 +245.1 13.7808890798687 3.09661312565763 0.805556651490164 +254.51 13.7817888550064 3.09661416507046 0.809467934912206 +242.18 13.7826886304475 3.09661520371633 0.807917020152706 +219.22 13.7835884061917 3.09661624159522 0.828981436952967 +231.7 13.7844881822389 3.09661727870715 0.827038204959322 +221.6 13.7853879585887 3.0966183150521 0.818206351737589 +232.65 13.786287735241 3.09661935063007 0.81325540081845 +237.67 13.7871875121956 3.09662038544107 0.817514611326843 +245.9 13.7880872894522 3.0966214194851 0.814660074739456 +252.07 13.7889870670105 3.09662245276214 0.81916775155805 +251.27 13.7898868448705 3.09662348527221 0.810673409533834 +240.93 13.7907866230318 3.09662451701529 0.811149447567358 +240.42 13.7916864014942 3.09662554799139 0.808290216047818 +239.73 13.7925861802576 3.09662657820051 0.812504123667328 +231.39 13.7934859593216 3.09662760764264 0.811008114610037 +225.51 13.7943857386861 3.09662863631779 0.816080775721518 +236.96 13.7952855183508 3.09662966422595 0.809810854306044 +238.9 13.7961852983155 3.09663069136712 0.809373721332528 +245.12 13.79708507858 3.09663171774131 0.806932364618627 +252.5 13.7979848591441 3.0966327433485 0.810402087982751 +247.08 13.7988846400075 3.0966337681887 0.811556524338787 +229.56 13.79978442117 3.0966347922619 0.802744410865903 +243.79 13.8006842026314 3.09663581556811 0.79516132353244 +248.27 13.7116084159362 3.09562631315074 0.813076227779452 +251.93 13.7125081662794 3.09562741129484 0.786139920869472 +244.62 13.7134079169432 3.0956285086723 0.79706543188168 +238.26 13.7143076679274 3.09562960528311 0.810953265023291 +247.33 13.7152074192317 3.09563070112728 0.814229106887302 +250.27 13.716107170856 3.0956317962048 0.80442756186312 +244.48 13.7170069228 3.09563289051567 0.809273964832672 +237.31 13.7179066750635 3.09563398405989 0.811713874592272 +236.25 13.7188064276463 3.09563507683746 0.809659423399524 +236.25 13.7197061805481 3.09563616884838 0.817580729964557 +234.94 13.7206059337687 3.09563726009264 0.811935270597865 +242.46 13.7215056873079 3.09563835057025 0.805029335863817 +241.73 13.7224054411655 3.09563944028119 0.815330701326354 +248.08 13.7233051953412 3.09564052922549 0.796689142968826 +248.33 13.7242049498348 3.09564161740312 0.806033413748788 +236.32 13.7251047046462 3.09564270481409 0.829064051577205 +231.34 13.726004459775 3.0956437914584 0.813606099823803 +232.33 13.726904215221 3.09564487733604 0.812077279309961 +232.43 13.7278039709841 3.09564596244702 0.81640119878904 +236.8 13.728703727064 3.09564704679133 0.793337356873879 +232.08 13.7296034834605 3.09564813036898 0.801689442056414 +231.84 13.7305032401733 3.09564921317995 0.805728149351317 +232.75 13.7314029972022 3.09565029522426 0.805147974139662 +244.22 13.7323027545471 3.09565137650189 0.810971800820989 +242.88 13.7332025122076 3.09565245701285 0.809748650272241 +250.53 13.7341022701836 3.09565353675714 0.810449592368618 +243.63 13.7350020284749 3.09565461573475 0.803918414248779 +238.18 13.7359017870811 3.09565569394568 0.813009990086174 +234.89 13.7368015460021 3.09565677138994 0.810980487977899 +246.36 13.7377013052377 3.09565784806752 0.788577409172598 +240.84 13.7386010647877 3.09565892397841 0.793165390701852 +242.63 13.7395008246517 3.09565999912262 0.804671713121853 +244.7 13.7404005848296 3.09566107350015 0.812297486728918 +244.68 13.7413003453213 3.09566214711099 0.810243161094225 +238.3 13.7422001061263 3.09566321995515 0.818811349430357 +226.85 13.7430998672446 3.09566429203262 0.817020516815998 +228.88 13.7439996286758 3.0956653633434 0.820547044184338 +236.44 13.7448993904199 3.09566643388749 0.798228469247723 +238.68 13.7457991524764 3.09566750366489 0.816294853455885 +240.86 13.7466989148453 3.0956685726756 0.834264901113116 +244.23 13.7475986775263 3.09566964091961 0.827799642345446 +239.5 13.7484984405192 3.09567070839692 0.824822817383304 +241.9 13.7493982038237 3.09567177510754 0.823330166321121 +242.16 13.7502979674397 3.09567284105146 0.824834554797103 +251.68 13.7511977313669 3.09567390622869 0.812749210678446 +243.79 13.752097495605 3.09567497063921 0.819921416543349 +242.98 13.7529972601539 3.09567603428302 0.799938954352314 +244.38 13.7538970250133 3.09567709716014 0.797797047852839 +241.38 13.7547967901831 3.09567815927055 0.797711205590098 +251.22 13.7556965556629 3.09567922061425 0.800396573358326 +244.03 13.7565963214526 3.09568028119125 0.799233763120951 +234.87 13.7574960875519 3.09568134100154 0.813462752586384 +228.56 13.7583958539606 3.09568240004512 0.805517270626153 +235.87 13.7592956206785 3.09568345832198 0.802998738772862 +245.53 13.7601953877054 3.09568451583214 0.793166870571234 +245.47 13.761095155041 3.09568557257558 0.794495035665097 +255.08 13.7619949226852 3.0956866285523 0.791888245721367 +267.18 13.7628946906376 3.09568768376231 0.784986880782813 +274.67 13.7637944588981 3.0956887382056 0.786241076845009 +253.39 13.7646942274665 3.09568979188217 0.796961852119629 +256.51 13.7655939963424 3.09569084479202 0.78962694981384 +240.6 13.7664937655258 3.09569189693515 0.788315821273532 +233.48 13.7673935350163 3.09569294831156 0.799611627974379 +244.05 13.7682933048138 3.09569399892124 0.793056741556491 +245.76 13.769193074918 3.09569504876419 0.790397353691226 +225.3 13.7700928453288 3.09569609784042 0.811178094219895 +239.33 13.7709926160458 3.09569714614993 0.796592935708003 +248.94 13.7718923870688 3.0956981936927 0.792355470220927 +247.04 13.7727921583977 3.09569924046874 0.79881947860305 +261.1 13.7736919300322 3.09570028647805 0.789577157364335 +256.61 13.774591701972 3.09570133172062 0.802876705058118 +258.92 13.775491474217 3.09570237619646 0.804452659121334 +253.09 13.776391246767 3.09570341990557 0.818327376697641 +251.6 13.7772910196217 3.09570446284794 0.810553352219075 +249.08 13.7781907927808 3.09570550502356 0.815232332287465 +238.06 13.7790905662442 3.09570654643245 0.817681961873005 +231.77 13.7799903400117 3.0957075870746 0.814790818946786 +237.87 13.780890114083 3.09570862695001 0.816174343107792 +246.37 13.7817898884578 3.09570966605867 0.809414359868264 +240.46 13.782689663136 3.09571070440059 0.813053683054236 +235.38 13.7835894381174 3.09571174197576 0.816747163223742 +224.03 13.7844892134017 3.09571277878418 0.819599837319277 +217.7 13.7853889889887 3.09571381482586 0.823915496261308 +224.15 13.7862887648781 3.09571485010078 0.817793816163336 +233.23 13.7871885410698 3.09571588460895 0.813559738737779 +237.27 13.7880883175635 3.09571691835038 0.83108966672513 +238.48 13.7889880943591 3.09571795132504 0.806899434492349 +234.63 13.7898878714562 3.09571898353295 0.808311435040574 +232.7 13.7907876488546 3.09572001497411 0.814295520715802 +234.35 13.7916874265542 3.09572104564851 0.814994319129834 +226.96 13.7925872045547 3.09572207555615 0.819211512898681 +225.62 13.7934869828558 3.09572310469702 0.812304818732331 +234.13 13.7943867614574 3.09572413307114 0.802213386891831 +233.56 13.7952865403593 3.09572516067849 0.815143392556396 +240.85 13.7961863195611 3.09572618751909 0.801527146370921 +252.93 13.7970860990627 3.09572721359291 0.802924353195197 +245.73 13.7979858788639 3.09572823889997 0.817337472756404 +241.68 13.7988856589645 3.09572926344026 0.809521169813861 +229.39 13.7997854393641 3.09573028721378 0.801224185376643 +239.32 13.8006852200626 3.09573131022053 0.803000317623201 +253.2 13.7116095085651 3.09472183852258 0.79188555849964 +247.21 13.7125092581458 3.09472293634523 0.7795131062021 +237.44 13.7134090080471 3.09472403340146 0.792348484233265 +244.22 13.7143087582687 3.09472512969127 0.810244267379446 +249.61 13.7152085088106 3.09472622521466 0.815852434977232 +239.62 13.7161082596723 3.09472731997162 0.813210702341137 +243.52 13.7170080108538 3.09472841396216 0.809704929280726 +237.01 13.7179077623548 3.09472950718627 0.810758793058893 +231.49 13.718807514175 3.09473059964396 0.809439947796074 +233.48 13.7197072663142 3.09473169133522 0.803571572996449 +233.39 13.7206070187723 3.09473278226004 0.814189375714793 +235.24 13.721506771549 3.09473387241844 0.802647738988634 +243.83 13.722406524644 3.09473496181041 0.804706316928192 +246.36 13.7233062780572 3.09473605043594 0.802985580086897 +241.99 13.7242060317883 3.09473713829503 0.808794287262748 +242.41 13.7251057858371 3.09473822538769 0.810491363816371 +237.37 13.7260055402034 3.09473931171391 0.811870597649967 +243.51 13.7269052948869 3.09474039727369 0.800225033134327 +244.52 13.7278050498874 3.09474148206703 0.803060968339138 +236.53 13.7287048052048 3.09474256609393 0.798988114691367 +233.67 13.7296045608387 3.09474364935439 0.794992263450111 +227.39 13.7305043167889 3.0947447318484 0.808526773938275 +228.51 13.7314040730553 3.09474581357596 0.817075753200501 +239.11 13.7323038296376 3.09474689453708 0.803098056289087 +253.38 13.7332035865356 3.09474797473175 0.805496579815947 +259.35 13.7341033437491 3.09474905415997 0.809524479163005 +242.28 13.7350031012777 3.09475013282173 0.810170397084359 +242.14 13.7359028591214 3.09475121071705 0.808052178795442 +242.7 13.7368026172799 3.09475228784591 0.80768274683446 +246.28 13.7377023757529 3.09475336420831 0.800595485225561 +245.05 13.7386021345403 3.09475443980426 0.785282628155152 +237.92 13.7395018936418 3.09475551463375 0.797389262382019 +234.69 13.7404016530571 3.09475658869679 0.804477624334626 +246.34 13.7413014127862 3.09475766199336 0.804793021449106 +242.35 13.7422011728286 3.09475873452347 0.805437918608827 +238.72 13.7431009331843 3.09475980628711 0.806396686426147 +232.3 13.744000693853 3.0947608772843 0.822278798472441 +234.12 13.7449004548345 3.09476194751501 0.812986138567352 +231.87 13.7458002161285 3.09476301697926 0.807764599131506 +238.11 13.7466999777348 3.09476408567704 0.799489444533799 +239.57 13.7475997396532 3.09476515360835 0.811670575890377 +245.85 13.7484995018835 3.09476622077319 0.811033716826362 +245.52 13.7493992644255 3.09476728717156 0.804862937105208 +244.77 13.7502990272789 3.09476835280345 0.811939163211743 +246.7 13.7511987904434 3.09476941766887 0.832037375742934 +248.39 13.752098553919 3.09477048176781 0.809546556919233 +248.08 13.7529983177053 3.09477154510027 0.817827373913293 +244.67 13.7538980818021 3.09477260766626 0.819067648830598 +245.88 13.7547978462093 3.09477366946576 0.820281107002582 +246.08 13.7556976109265 3.09477473049878 0.8117038896605 +244.22 13.7565973759536 3.09477579076532 0.809256413515273 +229.23 13.7574971412903 3.09477685026538 0.822962247352768 +224.2 13.7583969069365 3.09477790899895 0.804164283747432 +229.15 13.7592966728918 3.09477896696603 0.80629559666493 +242.7 13.7601964391561 3.09478002416662 0.808591379429546 +253.03 13.7610962057291 3.09478108060073 0.784614281788748 +243.29 13.7619959726107 3.09478213626834 0.796081019961617 +262.73 13.7628957398005 3.09478319116947 0.784273958739122 +274.96 13.7637955072984 3.0947842453041 0.772883568403961 +253.94 13.7646952751042 3.09478529867223 0.79185676299084 +259.28 13.7655950432175 3.09478635127387 0.789921363451236 +243.72 13.7664948116383 3.09478740310901 0.794636009073255 +230.92 13.7673945803662 3.09478845417765 0.810785433526951 +235.49 13.7682943494011 3.09478950447979 0.799830713016661 +235.98 13.7691941187427 3.09479055401544 0.809893793416066 +231.81 13.7700938883908 3.09479160278457 0.79440837848091 +241.28 13.7709936583452 3.09479265078721 0.803617290950936 +257.33 13.7718934286056 3.09479369802334 0.798929471032745 +253 13.7727931991719 3.09479474449296 0.797470393941835 +264.73 13.7736929700438 3.09479579019608 0.7886529699312 +256.6 13.774592741221 3.09479683513269 0.802380473895552 +253.47 13.7754925127034 3.09479787930278 0.803761419421017 +252.97 13.7763922844908 3.09479892270637 0.800402489529833 +254.7 13.7772920565828 3.09479996534344 0.808274415978924 +257.09 13.7781918289793 3.094801007214 0.792689732142857 +245.4 13.7790916016801 3.09480204831804 0.802212592738494 +243.21 13.7799913746849 3.09480308865557 0.815845219601751 +240.93 13.7808911479936 3.09480412822658 0.799132936066398 +241.22 13.7817909216058 3.09480516703107 0.80319777149699 +238.08 13.7826906955214 3.09480620506904 0.810069106311084 +229.61 13.7835904697402 3.09480724234048 0.813450847131999 +235.99 13.7844902442618 3.09480827884541 0.812024353120244 +247.23 13.7853900190862 3.09480931458381 0.80869786105808 +239.02 13.786289794213 3.09481034955568 0.804503886021341 +232.4 13.787189569642 3.09481138376103 0.808013447718175 +234.68 13.7880893453731 3.09481241719985 0.821158795509582 +232.19 13.788989121406 3.09481344987214 0.806148698634743 +228.93 13.7898888977405 3.0948144817779 0.813280901609438 +223.24 13.7907886743763 3.09481551291712 0.820984170600988 +227.82 13.7916884513132 3.09481654328982 0.825361423428731 +229.21 13.792588228551 3.09481757289598 0.811703773781558 +230.45 13.7934880060896 3.0948186017356 0.814294989459509 +233.07 13.7943877839285 3.09481962980869 0.80455307769972 +232.34 13.7952875620677 3.09482065711524 0.813326178624774 +246.82 13.7961873405069 3.09482168365524 0.796075816744452 +248.86 13.7970871192459 3.09482270942871 0.806258946825489 +241.76 13.7979868982845 3.09482373443564 0.813788757630053 +232.59 13.7988866776223 3.09482475867602 0.801438836960904 +231.33 13.7997864572593 3.09482578214986 0.81064854848672 +233.98 13.8006862371952 3.09482680485715 0.804064035821442 +240.07 13.7116106008732 3.09381736387858 0.814952624557696 +245.28 13.7125103496916 3.09381846137978 0.789380261501498 +236.67 13.7134100988306 3.09381955811478 0.799951751766795 +238.47 13.71430984829 3.09382065408358 0.808267561858898 +245.96 13.7152095980695 3.09382174928619 0.802451191909099 +238.53 13.7161093481689 3.0938228437226 0.825146171907371 +236.5 13.7170090985881 3.09382393739281 0.810792121518201 +232.54 13.7179088493267 3.09382503029681 0.819057252973957 +230.57 13.7188086003846 3.09382612243462 0.823856592268537 +234.78 13.7197083517616 3.09382721380622 0.817001271627298 +228.38 13.7206081034574 3.09382830441161 0.807306897168505 +238.59 13.7215078554717 3.0938293942508 0.812561308421917 +235.16 13.7224076078044 3.09383048332378 0.802538048929397 +238.93 13.7233073604553 3.09383157163055 0.811728347958794 +245.22 13.7242071134241 3.09383265917111 0.803502845154066 +240.89 13.7251068667106 3.09383374594546 0.810701883537451 +243.3 13.7260066203145 3.09383483195359 0.808616703408122 +235.41 13.7269063742357 3.09383591719551 0.812882018752598 +231.13 13.7278061284739 3.09383700167121 0.804822423110612 +242.13 13.7287058830289 3.09383808538069 0.799556978003632 +229.89 13.7296056379005 3.09383916832396 0.803691091772817 +237.01 13.7305053930885 3.09384025050101 0.788163735556233 +232.53 13.7314051485925 3.09384133191183 0.807054168980628 +239.67 13.7323049044125 3.09384241255643 0.798663227488743 +235.72 13.7332046605481 3.09384349243481 0.809289714817234 +250.64 13.7341044169992 3.09384457154696 0.807615274975473 +245.75 13.7350041737656 3.09384564989289 0.804232441611648 +234.35 13.7359039308469 3.09384672747258 0.80667755121689 +241.25 13.7368036882431 3.09384780428605 0.808349623550816 +239.69 13.7377034459538 3.09384888033328 0.800266913219735 +234.32 13.7386032039788 3.09384995561429 0.799413880037368 +246.88 13.7395029623179 3.09385103012906 0.814463756219001 +245.55 13.7404027209709 3.0938521038776 0.805297341101403 +241.4 13.7413024799376 3.09385317685989 0.796054572731088 +232.66 13.7422022392178 3.09385424907596 0.806524759537091 +235.36 13.7431019988111 3.09385532052578 0.804371685756442 +236.55 13.7440017587175 3.09385639120936 0.822018129236196 +235.34 13.7449015189366 3.0938574611267 0.813789960795405 +235.33 13.7458012794682 3.0938585302778 0.809571913621076 +239.04 13.7467010403122 3.09385959866266 0.806970210222178 +246.13 13.7476008014683 3.09386066628127 0.806806084955874 +245.62 13.7485005629362 3.09386173313363 0.820072861941874 +240.14 13.7494003247158 3.09386279921975 0.810646489799828 +248.57 13.7503000868068 3.09386386453961 0.819580936959071 +242.62 13.751199849209 3.09386492909322 0.792286494609391 +245.11 13.7520996119222 3.09386599288059 0.816798625634897 +246.95 13.7529993749462 3.0938670559017 0.80252392178616 +248.05 13.7538991382807 3.09386811815655 0.818280232858249 +241.79 13.7547989019255 3.09386917964515 0.809689955570073 +247.47 13.7556986658803 3.09387024036749 0.818635642818031 +239.56 13.756598430145 3.09387130032357 0.821788503502929 +234.7 13.7574981947194 3.0938723595134 0.813800052873766 +234.96 13.7583979596032 3.09387341793696 0.795810109875329 +237.16 13.7592977247961 3.09387447559426 0.800179252179731 +249.63 13.760197490298 3.0938755324853 0.801005204276575 +250.49 13.7610972561087 3.09387658861007 0.795907265483752 +265.81 13.7619970222279 3.09387764396857 0.796075887064298 +269 13.7628967886553 3.09387869856081 0.794559658879132 +258.14 13.7637965553909 3.09387975238678 0.796501475988756 +253.23 13.7646963224342 3.09388080544647 0.787769565411296 +243.35 13.7655960897852 3.0938818577399 0.808684635316296 +243.81 13.7664958574436 3.09388290926705 0.80659892243695 +240.83 13.7673956254091 3.09388396002793 0.806123955702351 +231.55 13.7682953936816 3.09388501002254 0.799290523175962 +230.2 13.7691951622609 3.09388605925086 0.80621873168068 +239.02 13.7700949311466 3.09388710771291 0.800802412139139 +245.01 13.7709947003386 3.09388815540868 0.795072422488251 +253.52 13.7718944698366 3.09388920233817 0.804844832309318 +261.63 13.7727942396405 3.09389024850138 0.795929051414284 +273.46 13.77369400975 3.0938912938983 0.792294807370184 +250.66 13.7745937801648 3.09389233852894 0.795834112168521 +247.18 13.7754935508848 3.0938933823933 0.804920043398273 +252.28 13.7763933219098 3.09389442549136 0.801323671914538 +254.66 13.7772930932394 3.09389546782314 0.796640908374074 +264.85 13.7781928648736 3.09389650938863 0.791427982530849 +257.7 13.779092636812 3.09389755018783 0.802245463987734 +239.87 13.7799924090544 3.09389859022073 0.816748249345175 +242.28 13.7808921816006 3.09389962948734 0.822136001633653 +244.68 13.7817919544505 3.09390066798766 0.807704385234963 +238.01 13.7826917276037 3.09390170572168 0.815509116592083 +227.84 13.78359150106 3.09390274268941 0.806030914486336 +233.53 13.7844912748192 3.09390377889083 0.806029628706185 +251.62 13.7853910488812 3.09390481432596 0.798398586426189 +243.74 13.7862908232456 3.09390584899478 0.801701700052715 +239.37 13.7871905979122 3.0939068828973 0.814030406404039 +235.48 13.7880903728809 3.09390791603352 0.821784842629311 +223.64 13.7889901481514 3.09390894840344 0.821266605772158 +224.25 13.7898899237234 3.09390998000704 0.816790586876489 +221.97 13.7907896995968 3.09391101084434 0.822500039412905 +222.77 13.7916894757713 3.09391204091533 0.815763420943378 +225.02 13.7925892522468 3.09391307022001 0.812568591263888 +234.44 13.7934890290229 3.09391409875838 0.814138325716161 +248.09 13.7943888060994 3.09391512653044 0.803232629352527 +240.05 13.7952885834762 3.09391615353618 0.806021810714443 +238.37 13.796188361153 3.09391717977561 0.808949549840877 +237.74 13.7970881391295 3.09391820524872 0.80744426385966 +233.03 13.7979879174056 3.09391922995551 0.806044579385095 +228.27 13.7988876959811 3.09392025389599 0.811970705017849 +232.54 13.7997874748556 3.09392127707014 0.814669959392342 +239.67 13.8006872540291 3.09392229947797 0.808203070689415 +235.6 13.7116116928605 3.09291288921874 0.80481144343303 +236.59 13.7125114409168 3.09291398639849 0.801110505736812 +236.9 13.7134111892937 3.09291508281226 0.790664239193679 +250.53 13.714310937991 3.09291617846006 0.791831838097225 +236.58 13.7152106870084 3.09291727334189 0.806770028031726 +231.06 13.7161104363458 3.09291836745774 0.82281434538384 +238.33 13.7170101860029 3.09291946080762 0.826075655017616 +231.62 13.7179099359795 3.09292055339152 0.819647908762186 +236.34 13.7188096862753 3.09292164520944 0.812118608302885 +245.75 13.7197094368901 3.09292273626138 0.819731913004882 +231.21 13.7206091878238 3.09292382654734 0.81691882118407 +240.17 13.7215089390761 3.09292491606732 0.799991901850427 +240.24 13.7224086906467 3.09292600482132 0.795034170183702 +235.28 13.7233084425355 3.09292709280933 0.815462392484597 +244.8 13.7242081947422 3.09292818003135 0.798874241197504 +243.3 13.7251079472665 3.09292926648739 0.808255435673886 +239.43 13.7260077001084 3.09293035217744 0.808455258902867 +239.06 13.7269074532675 3.09293143710149 0.805133022606014 +234.07 13.7278072067436 3.09293252125956 0.813549973208939 +229.35 13.7287069605365 3.09293360465163 0.821042356498938 +229.1 13.729606714646 3.09293468727771 0.80273653958796 +235.65 13.7305064690718 3.09293576913779 0.806348470240783 +227.68 13.7314062238138 3.09293685023187 0.809542357958119 +231.15 13.7323059788717 3.09293793055996 0.806046576306124 +237.5 13.7332057342452 3.09293901012204 0.809216787209745 +245 13.7341054899342 3.09294008891813 0.807440144498674 +239.31 13.7350052459384 3.09294116694821 0.805321907412092 +235.59 13.7359050022577 3.09294224421229 0.805057145021188 +241.97 13.7368047588917 3.09294332071036 0.807116677454325 +235.93 13.7377045158403 3.09294439644243 0.799828579036714 +243.95 13.7386042731032 3.09294547140849 0.795176212631692 +238.71 13.7395040306802 3.09294654560854 0.811326904794242 +243.11 13.7404037885711 3.09294761904258 0.797097965425918 +235.82 13.7413035467757 3.09294869171061 0.806382198312752 +235.6 13.7422033052937 3.09294976361262 0.805271211811651 +233.89 13.7431030641249 3.09295083474862 0.807396752993905 +226.85 13.7440028232691 3.09295190511861 0.81199865156309 +230.3 13.7449025827261 3.09295297472258 0.82211039495705 +231.62 13.7458023424956 3.09295404356053 0.822730250424322 +229 13.7467021025775 3.09295511163246 0.810197154795309 +238.96 13.7476018629714 3.09295617893837 0.812017400761283 +247.77 13.7485016236772 3.09295724547825 0.805063262359749 +246.26 13.7494013846947 3.09295831125212 0.796134935326785 +250.33 13.7503011460236 3.09295937625996 0.798752704008837 +236.4 13.7512009076637 3.09296044050177 0.812092662595716 +244.67 13.7521006696147 3.09296150397755 0.800650112727385 +241.47 13.7530004318765 3.09296256668731 0.797780317954455 +240.07 13.7539001944489 3.09296362863103 0.812426169835352 +239.09 13.7547999573315 3.09296468980873 0.810119005426521 +238.24 13.7556997205243 3.09296575022039 0.814187989137285 +241.11 13.7565994840268 3.09296680986602 0.814841749617442 +240.03 13.757499247839 3.09296786874561 0.806281446540881 +245.7 13.7583990119607 3.09296892685916 0.782432635534085 +256.87 13.7592987763915 3.09296998420668 0.790343923088633 +250 13.7601985411313 3.09297104078816 0.79116080893911 +267.8 13.7610983061798 3.09297209660359 0.789774524336663 +263.95 13.7619980715368 3.09297315165299 0.783688408302436 +265.04 13.7628978372021 3.09297420593634 0.78318651187212 +252.26 13.7637976031755 3.09297525945365 0.802894623672283 +246.89 13.7646973694567 3.09297631220491 0.803262454049943 +244.27 13.7655971360455 3.09297736419013 0.800441274811697 +238.88 13.7664969029417 3.09297841540929 0.794784766851301 +231.2 13.7673966701451 3.09297946586241 0.804246184971811 +230.96 13.7682964376555 3.09298051554947 0.814019213185613 +236.23 13.7691962054725 3.09298156447049 0.795785398275361 +248.26 13.7700959735961 3.09298261262545 0.792873363887857 +251.62 13.7709957420259 3.09298366001435 0.804831421619743 +248.99 13.7718955107618 3.0929847066372 0.801788215871706 +254.48 13.7727952798035 3.09298575249399 0.808692328274913 +259.12 13.7736950491508 3.09298679758472 0.799908112868027 +256.12 13.7745948188035 3.09298784190939 0.788692562422953 +243.65 13.7754945887613 3.09298888546801 0.803269409910423 +241.98 13.7763943590241 3.09298992826055 0.802766672449058 +251.43 13.7772941295916 3.09299097028704 0.803612400825074 +254.47 13.7781939004636 3.09299201154746 0.797882482033004 +250.5 13.7790936716398 3.09299305204181 0.80787263699932 +244.59 13.77999344312 3.09299409177009 0.808599200164786 +246.52 13.7808932149041 3.09299513073231 0.814224528143995 +252.43 13.7817929869917 3.09299616892846 0.821513174484226 +239.54 13.7826927593828 3.09299720635853 0.803049168758796 +228.11 13.7835925320769 3.09299824302253 0.811914962412093 +237.9 13.784492305074 3.09299927892046 0.810616872183827 +242.59 13.7853920783737 3.09300031405231 0.803906821775012 +249.56 13.786291851976 3.09300134841808 0.80133891551888 +236.35 13.7871916258804 3.09300238201778 0.813596375597747 +234.61 13.7880914000869 3.0930034148514 0.818854031309944 +235 13.7889911745952 3.09300444691894 0.83027576536574 +218.42 13.789890949405 3.09300547822039 0.814839350778404 +220.31 13.7907907245162 3.09300650875576 0.818142331436385 +215.22 13.7916904999286 3.09300753852505 0.826089355747817 +225.73 13.7925902756418 3.09300856752825 0.814555693541049 +234.58 13.7934900516557 3.09300959576537 0.813469999516511 +244.77 13.79438982797 3.0930106232364 0.799073991774203 +237.66 13.7952896045846 3.09301164994133 0.815611904808311 +238.62 13.7961893814992 3.09301267588018 0.809770941945224 +229.72 13.7970891587136 3.09301370105294 0.814049751243781 +236.31 13.7979889362275 3.0930147254596 0.809984063333347 +234.5 13.7988887140407 3.09301574910016 0.802192496899373 +240.04 13.7997884921531 3.09301677197464 0.808667805976585 +248.41 13.8006882705643 3.09301779408301 0.81109619140625 +231.67 13.711612784527 3.09200841454307 0.805723035697196 +230 13.7125125318214 3.09200951140136 0.812975882843068 +230.9 13.7134122794365 3.09201060749391 0.81460783021866 +237.19 13.7143120273719 3.0920117028207 0.800589889677737 +236.31 13.7152117756275 3.09201279738175 0.793300995072569 +247.35 13.716111524203 3.09201389117705 0.800588070367149 +239.91 13.7170112730982 3.0920149842066 0.820199683212017 +237.19 13.7179110223129 3.09201607647039 0.816007700281356 +238.78 13.7188107718469 3.09201716796843 0.810418802445229 +234.72 13.7197105216999 3.09201825870072 0.815214043732676 +227.52 13.7206102718717 3.09201934866725 0.809996760423031 +232.05 13.7215100223621 3.09202043786802 0.809794432358034 +241.85 13.7224097731708 3.09202152630303 0.798128131598021 +232.99 13.7233095242977 3.09202261397228 0.818840359616086 +238.93 13.7242092757426 3.09202370087577 0.811852129625732 +239.28 13.7251090275051 3.0920247870135 0.805445821671331 +243.17 13.726008779585 3.09202587238546 0.803742747789569 +233.46 13.7269085319823 3.09202695699165 0.807751875777394 +232.32 13.7278082846965 3.09202804083208 0.813756226365127 +231.48 13.7287080377275 3.09202912390674 0.807761044703263 +227.75 13.7296077910751 3.09203020621563 0.811629870913259 +238.9 13.7305075447391 3.09203128775875 0.803290119622498 +233.67 13.7314072987192 3.09203236853609 0.800104905584973 +237.42 13.7323070530152 3.09203344854766 0.817803734841158 +238.22 13.7332068076268 3.09203452779346 0.807949613675836 +234.23 13.7341065625539 3.09203560627348 0.804820054827205 +232.58 13.7350063177963 3.09203668398772 0.810703861918136 +249.86 13.7359060733536 3.09203776093618 0.805368120032125 +240.09 13.7368058292257 3.09203883711886 0.796421072684278 +244.71 13.7377055854124 3.09203991253576 0.800410310737255 +237.68 13.7386053419134 3.09204098718687 0.806537928366485 +238.63 13.7395050987286 3.09204206107221 0.795743091859597 +244.91 13.7404048558576 3.09204313419175 0.805799392283846 +236.59 13.7413046133003 3.09204420654551 0.80461186267693 +228.37 13.7422043710564 3.09204527813348 0.805457199912738 +232.08 13.7431041291257 3.09204634895565 0.820543334899868 +228.38 13.744003887508 3.09204741901204 0.815703125309972 +232.1 13.7449036462031 3.09204848830264 0.821307925845588 +236 13.7458034052107 3.09204955682744 0.806059232702214 +235.29 13.7467031645307 3.09205062458644 0.80699357445681 +242.23 13.7476029241627 3.09205169157965 0.805752270580687 +238.87 13.7485026841066 3.09205275780707 0.804095596185189 +241.16 13.7494024443622 3.09205382326868 0.797707200669143 +249.39 13.7503022049291 3.09205488796449 0.79615928562245 +245.73 13.7512019658073 3.0920559518945 0.805407597881654 +249.49 13.7521017269965 3.09205701505871 0.812717910913693 +244.12 13.7530014884964 3.09205807745711 0.807217875519842 +239.05 13.7539012503068 3.0920591390897 0.80607918752545 +249.04 13.7548010124275 3.09206019995649 0.800257949186362 +241.54 13.7557007748583 3.09206126005748 0.821001729398676 +247.88 13.756600537599 3.09206231939265 0.802345481903493 +240.5 13.7575003006493 3.09206337796201 0.796900287581275 +251.75 13.758400064009 3.09206443576556 0.788098824453977 +253.04 13.7592998276779 3.09206549280329 0.792552955371807 +268.74 13.7601995916557 3.09206654907521 0.779681782277175 +263.02 13.7610993559423 3.09206760458132 0.793574383660664 +253.24 13.7619991205374 3.0920686593216 0.799131107447316 +251.04 13.7628988854408 3.09206971329607 0.802832651486217 +251.28 13.7637986506522 3.09207076650472 0.797530020084612 +244.97 13.7646984161715 3.09207181894754 0.79514101651127 +257.72 13.7655981819984 3.09207287062455 0.782941552564496 +235.49 13.7664979481327 3.09207392153573 0.796459993101184 +235.61 13.7673977145742 3.09207497168108 0.807515961442163 +244.1 13.7682974813226 3.09207602106061 0.795588034968789 +248.12 13.7691972483777 3.09207706967431 0.799984414572375 +253.17 13.7700970157393 3.09207811752218 0.804361888919693 +251.67 13.7709967834072 3.09207916460422 0.790966577827807 +251.12 13.7718965513811 3.09208021092043 0.801092013085329 +255.07 13.7727963196609 3.0920812564708 0.804511043349588 +255.11 13.7736960882463 3.09208230125534 0.815603201787591 +245.61 13.774595857137 3.09208334527405 0.812225368986552 +247 13.7754956263329 3.09208438852692 0.794187685666728 +241.42 13.7763953958337 3.09208543101395 0.804929821004806 +264.71 13.7772951656393 3.09208647273514 0.795540384887668 +254.46 13.7781949357493 3.09208751369049 0.786727303901957 +254.24 13.7790947061635 3.09208855388 0.793041195460655 +250.59 13.7799944768818 3.09208959330366 0.804879729295218 +241.13 13.780894247904 3.09209063196148 0.805524636681455 +247.9 13.7817940192297 3.09209166985346 0.800371121563889 +232.64 13.7826937908587 3.09209270697958 0.818920913625948 +228.5 13.7835935627909 3.09209374333986 0.805410140190971 +236.73 13.784493335026 3.09209477893429 0.805157996218187 +243.38 13.7853931075638 3.09209581376287 0.809541040476069 +247.86 13.7862928804041 3.09209684782559 0.812585198873103 +232.03 13.7871926535466 3.09209788112247 0.808803796432662 +234.67 13.7880924269911 3.09209891365348 0.81737088474177 +238.89 13.7889922007374 3.09209994541865 0.819999924130632 +227.93 13.7898919747853 3.09210097641795 0.823208209539004 +223.06 13.7907917491345 3.0921020066514 0.821483959850423 +220.59 13.7916915237849 3.09210303611898 0.807109332922982 +229.01 13.7925912987362 3.09210406482071 0.805596823096509 +232.89 13.7934910739881 3.09210509275657 0.803507922461723 +241.03 13.7943908495405 3.09210611992657 0.812899135624932 +231.33 13.7952906253931 3.0921071463307 0.808758484961314 +226.96 13.7961904015457 3.09210817196897 0.808209956860991 +231.86 13.7970901779981 3.09210919684136 0.798624779749882 +229.15 13.79798995475 3.0921102209479 0.805887612453228 +232.4 13.7988897318013 3.09211124428856 0.814383199577106 +233.83 13.7997895091516 3.09211226686335 0.80690121517074 +244.75 13.8006892868009 3.09211328867226 0.810520168965805 +236.43 13.7116138758726 3.09110393985157 0.811836984192078 +234.16 13.7125136224054 3.09110503638841 0.815548598515917 +230.38 13.7134133692589 3.09110613215972 0.814235551897053 +234.49 13.7143131164327 3.09110722716552 0.809195420437599 +236.7 13.7152128639266 3.09110832140579 0.819105965460244 +243.94 13.7161126117405 3.09110941488053 0.796338158100386 +247.76 13.7170123598741 3.09111050758975 0.792895329859685 +247.5 13.7179121083271 3.09111159953344 0.794282594105134 +233.92 13.7188118570994 3.0911126907116 0.79951939025673 +232.45 13.7197116061908 3.09111378112423 0.809799298634914 +232.06 13.720611355601 3.09111487077133 0.811101494885917 +229.51 13.7215111053297 3.09111595965289 0.814583431933993 +234.98 13.7224108553768 3.09111704776892 0.803006907761073 +230.14 13.7233106057421 3.09111813511941 0.810605360164978 +238.59 13.7242103564253 3.09111922170437 0.809716395692772 +234.36 13.7251101074261 3.09112030752378 0.812380602062247 +239.9 13.7260098587444 3.09112139257766 0.809413163936815 +237.71 13.72690961038 3.09112247686599 0.808876370996846 +232.67 13.7278093623326 3.09112356038878 0.823374710317711 +229.32 13.728709114602 3.09112464314603 0.812825877051818 +232.7 13.7296088671879 3.09112572513773 0.804069471576079 +238.56 13.7305086200902 3.09112680636389 0.80475571391885 +234.27 13.7314083733087 3.09112788682449 0.80871118006149 +235.62 13.732308126843 3.09112896651955 0.798674150940254 +237.32 13.733207880693 3.09113004544905 0.804604736953789 +233.03 13.7341076348584 3.09113112361301 0.801978160384931 +238.85 13.7350073893391 3.09113220101141 0.821660462297637 +237.68 13.7359071441348 3.09113327764425 0.799232986467341 +236.22 13.7368068992452 3.09113435351154 0.802777858952897 +238.31 13.7377066546703 3.09113542861327 0.809729755466589 +235.92 13.7386064104096 3.09113650294944 0.812827565552517 +240.28 13.7395061664631 3.09113757652005 0.806781971813123 +247.75 13.7404059228304 3.0911386493251 0.798033796588756 +240.78 13.7413056795114 3.09113972136459 0.809044062763193 +232.32 13.7422054365059 3.09114079263851 0.799667487530782 +233.23 13.7431051938135 3.09114186314687 0.80649648241206 +241.51 13.7440049514341 3.09114293288966 0.800164771791069 +239.26 13.7449047093676 3.09114400186689 0.801860075547429 +245.15 13.7458044676135 3.09114507007854 0.797511129516513 +247.68 13.7467042261718 3.09114613752462 0.808735475685795 +244.65 13.7476039850421 3.09114720420513 0.805303982148307 +240.2 13.7485037442243 3.09114827012007 0.80348855431127 +238.79 13.7494035037182 3.09114933526943 0.807365828605167 +245.22 13.7503032635235 3.09115039965321 0.801482402944073 +250.5 13.75120302364 3.09115146327142 0.806809279451839 +254.39 13.7521027840674 3.09115252612405 0.806937766966116 +249.74 13.7530025448057 3.0911535882111 0.810508873610101 +246.4 13.7539023058544 3.09115464953257 0.804171490268991 +237.15 13.7548020672134 3.09115571008846 0.81192893696434 +240.37 13.7557018288825 3.09115676987876 0.81923411179527 +241.15 13.7566015908615 3.09115782890348 0.820659356887068 +245 13.7575013531501 3.09115888716261 0.792458889501898 +246.17 13.7584011157481 3.09115994465615 0.794212671482537 +251.93 13.7593008786553 3.0911610013841 0.778495498703016 +261.26 13.7602006418715 3.09116205734646 0.797938634863625 +246.25 13.7611004053963 3.09116311254323 0.80152542985553 +244.97 13.7620001692297 3.09116416697441 0.803723634859459 +252.82 13.7628999333714 3.09116522064 0.804614384833002 +257.94 13.7637996978211 3.09116627353998 0.796186593300482 +246.34 13.7646994625787 3.09116732567438 0.794756394064432 +248.44 13.7655992276439 3.09116837704317 0.787591472583286 +242.29 13.7664989930165 3.09116942764636 0.791893071996895 +238.78 13.7673987586962 3.09117047748395 0.796521977269615 +252.9 13.7682985246829 3.09117152655594 0.785813595511197 +249.23 13.7691982909763 3.09117257486233 0.797433773515778 +255.88 13.7700980575763 3.09117362240311 0.79885010363119 +254.36 13.7709978244824 3.09117466917829 0.812417816771456 +249.67 13.7718975916947 3.09117571518786 0.804105058141545 +258.38 13.7727973592127 3.09117676043182 0.795246308926622 +249.98 13.7736971270364 3.09117780491017 0.806992165789854 +235.28 13.7745968951654 3.09117884862291 0.807623009893206 +230.86 13.7754966635996 3.09117989157003 0.811973140164749 +238.38 13.7763964323387 3.09118093375155 0.804998304645272 +249.6 13.7772962013825 3.09118197516745 0.802064211148316 +256.42 13.7781959707307 3.09118301581773 0.800760398448787 +249.24 13.7790957403833 3.09118405570239 0.798033034828942 +247.38 13.7799955103399 3.09118509482144 0.805660064926313 +242.46 13.7808952806002 3.09118613317486 0.818358961009985 +244.26 13.7817950511642 3.09118717076267 0.808102446543615 +234.57 13.7826948220315 3.09118820758485 0.822447249821708 +231.49 13.783594593202 3.0911892436414 0.813507381204616 +241.05 13.7844943646754 3.09119027893233 0.816102568016179 +245.53 13.7853941364514 3.09119131345764 0.802489177489177 +242.42 13.78629390853 3.09119234721732 0.80947173220484 +240.27 13.7871936809107 3.09119338021137 0.818192174926804 +234.37 13.7880934535935 3.09119441243978 0.810310553882955 +243.43 13.7889932265781 3.09119544390257 0.824775406515114 +240.13 13.7898929998642 3.09119647459972 0.817893614005774 +225.26 13.7907927734517 3.09119750453124 0.810929965176969 +223.21 13.7916925473403 3.09119853369713 0.815141174549958 +230.56 13.7925923215298 3.09119956209737 0.808854767622488 +241.17 13.79349209602 3.09120058973198 0.805927278569553 +244.89 13.7943918708107 3.09120161660095 0.802890208070996 +233.33 13.7952916459015 3.09120264270428 0.805711095557111 +229.51 13.7961914212924 3.09120366804197 0.801037471844925 +230.36 13.797091196983 3.09120469261401 0.81666114409131 +228.59 13.7979909729732 3.09120571642041 0.817709548227424 +236.84 13.7988907492627 3.09120673946117 0.823651149474756 +247.86 13.7997905258513 3.09120776173627 0.829996382030295 +251.43 13.8006903027388 3.09120878324573 0.812469534829657 +240.99 13.7116149668974 3.09019946514424 0.82035162947213 +242.14 13.7125147126689 3.09020056135963 0.805934248464335 +232.96 13.7134144587609 3.09020165680972 0.807875413217359 +234.82 13.7143142051733 3.09020275149451 0.788217352385373 +238.36 13.7152139519058 3.090203845414 0.808386846203446 +242.85 13.7161136989583 3.09020493856819 0.807059782485641 +240.69 13.7170134463304 3.09020603095708 0.796908918863759 +247.9 13.7179131940221 3.09020712258067 0.806319104268719 +238.73 13.718812942033 3.09020821343895 0.793832262883961 +233.63 13.7197126903629 3.09020930353192 0.822353117868355 +239.88 13.7206124390117 3.09021039285959 0.816818803855813 +236.23 13.721512187979 3.09021148142194 0.80336425978217 +232.71 13.7224119372647 3.09021256921899 0.810224106408629 +236.13 13.7233116868685 3.09021365625072 0.807794623609299 +233.11 13.7242114367903 3.09021474251715 0.804658736041411 +231.93 13.7251111870297 3.09021582801825 0.814492458693049 +233.29 13.7260109375866 3.09021691275404 0.817942991255631 +231.2 13.7269106884607 3.09021799672452 0.797499211578292 +229.59 13.7278104396519 3.09021907992967 0.794688429975651 +225.23 13.7287101911599 3.09022016236951 0.798403022237486 +234.61 13.7296099429844 3.09022124404402 0.795765380066301 +240.9 13.7305096951252 3.09022232495321 0.800883973440433 +236.7 13.7314094475822 3.09022340509708 0.806764375204007 +231.19 13.7323092003551 3.09022448447562 0.803002517379924 +235.62 13.7332089534437 3.09022556308884 0.815006964333224 +233.18 13.7341087068477 3.09022664093673 0.814725209546256 +239.02 13.7350084605669 3.09022771801928 0.811421880280085 +232.3 13.7359082146012 3.09022879433651 0.796825119549315 +235.32 13.7368079689502 3.09022986988841 0.797821048535805 +235.79 13.7377077236138 3.09023094467497 0.805107537936423 +246.08 13.7386074785917 3.0902320186962 0.800765489195439 +238.79 13.7395072338837 3.09023309195209 0.805320885704776 +240.83 13.7404069894896 3.09023416444265 0.804089222284911 +249.5 13.7413067454091 3.09023523616787 0.794404482772324 +239.05 13.7422065016421 3.09023630712775 0.803512782472883 +224.76 13.7431062581883 3.09023737732228 0.802945922462659 +240.36 13.7440060150475 3.09023844675148 0.796989058511762 +239.55 13.7449057722195 3.09023951541533 0.792972789692295 +242.56 13.745805529704 3.09024058331383 0.795159161396377 +239.79 13.7467052875008 3.09024165044699 0.805894060686639 +240.56 13.7476050456097 3.0902427168148 0.809839694776342 +236.15 13.7485048040304 3.09024378241726 0.806170138817901 +239.35 13.7494045627628 3.09024484725438 0.78505967188063 +242.66 13.7503043218067 3.09024591132614 0.804097209549577 +239.9 13.7512040811617 3.09024697463254 0.813702818475292 +250.16 13.7521038408277 3.0902480371736 0.802220944328743 +245.15 13.7530036008044 3.0902490989493 0.803555223821964 +236.03 13.7539033610917 3.09025015995964 0.811565237536173 +237.97 13.7548031216893 3.09025122020462 0.812192115801867 +243.99 13.7557028825969 3.09025227968424 0.810093512520842 +245.33 13.7566026438144 3.0902533383985 0.808311084780451 +247.68 13.7575024053415 3.0902543963474 0.799649172711326 +241.45 13.7584021671781 3.09025545353094 0.809487210656544 +256.95 13.7593019293238 3.09025650994911 0.794959465736155 +249.52 13.7602016917785 3.09025756560192 0.797877431523238 +248.7 13.7611014545419 3.09025862048936 0.79637762665787 +241.35 13.7620012176138 3.09025967461143 0.797339387647099 +248.72 13.762900980994 3.09026072796813 0.802027195258098 +260.61 13.7638007446822 3.09026178055946 0.792822940682083 +248.18 13.7647005086783 3.09026283238541 0.792407316525399 +246.75 13.765600272982 3.090263883446 0.798937190346812 +245.8 13.7665000375931 3.0902649337412 0.795787905575746 +245.28 13.7673998025114 3.09026598327103 0.781455917380948 +257.93 13.7682995677366 3.09026703203549 0.792118206981699 +250.69 13.7691993332685 3.09026808003456 0.785976416546697 +255.68 13.7700990991069 3.09026912726826 0.789887545105202 +252.88 13.7709988652516 3.09027017373657 0.804038239083253 +249.71 13.7718986317024 3.0902712194395 0.803220537129862 +257.56 13.7727983984589 3.09027226437704 0.794074801406852 +242.43 13.7736981655211 3.0902733085492 0.809004807936812 +228.47 13.7745979328886 3.09027435195598 0.820061705863594 +228.03 13.7754977005613 3.09027539459736 0.805904275365353 +245.12 13.7763974685389 3.09027643647336 0.807300043225477 +248.39 13.7772972368212 3.09027747758396 0.813362156526805 +246.73 13.778197005408 3.09027851792918 0.806195928703308 +238.55 13.779096774299 3.090279557509 0.807087740505692 +253.64 13.7799965434941 3.09028059632343 0.801797794892203 +245.85 13.7808963129929 3.09028163437246 0.802426588057042 +242.47 13.7817960827954 3.09028267165609 0.80792303908849 +239.11 13.7826958529012 3.09028370817432 0.821399173916735 +231.23 13.7835956233102 3.09028474392716 0.81486204683991 +247.42 13.784495394022 3.09028577891459 0.801143672931505 +243.22 13.7853951650366 3.09028681313663 0.807472411614449 +241.76 13.7862949363536 3.09028784659326 0.811202891269721 +240.56 13.7871947079729 3.09028887928448 0.817998412107869 +237.62 13.7880944798941 3.0902899112103 0.811845739967846 +240.2 13.7889942521172 3.09029094237071 0.832094158771553 +239.54 13.7898940246418 3.09029197276571 0.803145338435644 +226.23 13.7907937974678 3.09029300239531 0.812995157356084 +234.6 13.7916935705949 3.09029403125949 0.806164493803316 +239.12 13.7925933440229 3.09029505935826 0.802294205344932 +248.46 13.7934931177515 3.09029608669162 0.795347183821787 +244.62 13.7943928917806 3.09029711325956 0.807811516769395 +237.11 13.7952926661099 3.09029813906208 0.817727346711001 +219.33 13.7961924407393 3.09029916409919 0.819295755447029 +236.43 13.7970922156684 3.09030018837088 0.817193117766897 +238.2 13.797991990897 3.09030121187715 0.805755965438865 +239.55 13.798891766425 3.090302234618 0.80743622413318 +256.01 13.7997915422521 3.09030325659343 0.815180205266927 +251.64 13.8006913183781 3.09030427780343 0.80700610783091 +229.55 13.7116160576014 3.08929499042109 0.815927888624122 +232.19 13.7125158026117 3.08929608631503 0.809789570351452 +224.28 13.7134155479425 3.08929718144389 0.810020302679792 +218.38 13.7143152935937 3.08929827580769 0.815727230594665 +240.51 13.715215039565 3.0892993694064 0.793123458581169 +237.25 13.7161147858563 3.08930046224004 0.812044906419276 +246.57 13.7170145324673 3.0893015543086 0.802237714883728 +242.33 13.7179142793978 3.08930264561208 0.792834319436163 +248.4 13.7188140266475 3.08930373615048 0.797695569440074 +243.71 13.7197137742162 3.0893048259238 0.808414094880052 +236.01 13.7206135221038 3.08930591493203 0.819999779519573 +245.97 13.7215132703099 3.08930700317518 0.790119084874738 +246.65 13.7224130188344 3.08930809065325 0.804043487272248 +230.03 13.723312767677 3.08930917736622 0.810043799124018 +233.85 13.7242125168376 3.08931026331411 0.805153088845668 +228.7 13.7251122663158 3.08931134849691 0.799879893372966 +223.54 13.7260120161115 3.08931243291461 0.805625800795738 +228.45 13.7269117662245 3.08931351656723 0.799747453489351 +232.34 13.7278115166544 3.08931459945475 0.805605150458962 +233.7 13.7287112674012 3.08931568157717 0.796003048522314 +239.25 13.7296110184645 3.0893167629345 0.799075231396384 +247.08 13.7305107698441 3.08931784352673 0.797101904698308 +233.96 13.7314105215399 3.08931892335386 0.804868257193419 +235.83 13.7323102735516 3.08932000241589 0.809044254489498 +234.97 13.7332100258789 3.08932108071281 0.806800687664106 +236.09 13.7341097785217 3.08932215824464 0.806258829085195 +238.08 13.7350095314798 3.08932323501136 0.809695079888511 +230.75 13.7359092847528 3.08932431101297 0.805458092933285 +236.67 13.7368090383406 3.08932538624947 0.799049151790846 +244.58 13.7377087922429 3.08932646072087 0.801181570722855 +240.95 13.7386085464596 3.08932753442716 0.793324721863411 +242.8 13.7395083009904 3.08932860736833 0.807113903446866 +240.65 13.7404080558351 3.08932967954439 0.808980540226547 +252.93 13.7413078109934 3.08933075095534 0.799096191091027 +240.39 13.7422075664652 3.08933182160117 0.795246724048254 +233.2 13.7431073222502 3.08933289148189 0.799465229488297 +243.09 13.7440070783481 3.08933396059749 0.799829666089557 +245.05 13.7449068347588 3.08933502894797 0.801686929850912 +244.84 13.7458065914821 3.08933609653333 0.803598670211712 +238.05 13.7467063485177 3.08933716335356 0.805478783937571 +243.54 13.7476061058653 3.08933822940867 0.808654736735149 +246.47 13.7485058635249 3.08933929469866 0.803937941383833 +236.57 13.749405621496 3.08934035922353 0.795263388114729 +238.45 13.7503053797786 3.08934142298326 0.799478301322523 +240.44 13.7512051383724 3.08934248597787 0.812258322247346 +241.73 13.7521048972772 3.08934354820734 0.802059113928082 +240.44 13.7530046564927 3.08934460967169 0.816870644261308 +240.1 13.7539044160187 3.0893456703709 0.819512410175021 +243.78 13.754804175855 3.08934673030498 0.800793870580633 +235.42 13.7557039360014 3.08934778947393 0.806453695521473 +244.45 13.7566036964577 3.08934884787774 0.802636719930074 +247.95 13.7575034572236 3.08934990551641 0.801756528819869 +244.46 13.7584032182988 3.08935096238994 0.797846271081076 +248.5 13.7593029796833 3.08935201849833 0.804278812974465 +244.12 13.7602027413767 3.08935307384158 0.808916346373018 +238.45 13.7611025033789 3.08935412841969 0.801174579218478 +240.39 13.7620022656895 3.08935518223265 0.81026928149062 +241.73 13.7629020283085 3.08935623528047 0.80523587309033 +247.45 13.7638017912355 3.08935728756314 0.8062458918902 +240.04 13.7647015544703 3.08935833908066 0.809991343746832 +239.59 13.7656013180128 3.08935938983303 0.808963465088155 +243.88 13.7665010818626 3.08936043982025 0.798495321622938 +256.03 13.7674008460196 3.08936148904233 0.79006788195551 +243.66 13.7683006104835 3.08936253749924 0.789433387636698 +242.63 13.7692003752542 3.08936358519101 0.809001174539713 +240.7 13.7701001403313 3.08936463211761 0.799121705889283 +242.53 13.7709999057148 3.08936567827906 0.798083990686864 +248.27 13.7718996714042 3.08936672367535 0.810274370230963 +251.33 13.7727994373995 3.08936776830648 0.802474215384129 +232.11 13.7736992037004 3.08936881217245 0.808259587020649 +232.32 13.7745989703066 3.08936985527326 0.813367121187447 +235.12 13.7754987372181 3.08937089760891 0.814957466918715 +244.63 13.7763985044344 3.08937193917939 0.808755561484318 +236.07 13.7772982719554 3.0893729799847 0.824709811248584 +237.69 13.7781980397809 3.08937402002485 0.811220648031232 +235.16 13.7790978079107 3.08937505929982 0.819760336359234 +237.52 13.7799975763445 3.08937609780963 0.815774586678555 +234.72 13.7808973450821 3.08937713555427 0.822390289793584 +239.01 13.7817971141232 3.08937817253373 0.81059286697826 +237.01 13.7826968834678 3.08937920874802 0.827556259697598 +231 13.7835966531154 3.08938024419714 0.814163760971504 +238.92 13.784496423066 3.08938127888108 0.809629840125502 +243.67 13.7853961933193 3.08938231279984 0.818684700316627 +237.8 13.786295963875 3.08938334595342 0.821450619607607 +239.14 13.787195734733 3.08938437834182 0.813330233279082 +238.26 13.7880955058929 3.08938540996504 0.812077927230885 +229.87 13.7889952773547 3.08938644082308 0.822445096923031 +228.06 13.789895049118 3.08938747091593 0.825128780403618 +235.08 13.7907948211827 3.0893885002436 0.819054446666415 +232.1 13.7916945935485 3.08938952880608 0.825441298034367 +242.5 13.7925943662152 3.08939055660337 0.807354815933473 +251.48 13.7934941391826 3.08939158363548 0.792630563636647 +236.59 13.7943939124504 3.08939260990239 0.805452978341491 +235.81 13.7952936860184 3.08939363540411 0.810522000654324 +221.18 13.7961934598864 3.08939466014064 0.81823117345099 +234.21 13.7970932340542 3.08939568411198 0.814564687668025 +235.43 13.7979930085216 3.08939670731812 0.807905486583901 +234.22 13.7988927832882 3.08939772975906 0.809455691014441 +246.08 13.799792558354 3.08939875143481 0.808684324455036 +251.94 13.8006923337187 3.08939977234536 0.827205483763792 diff -r 000000000000 -r 33a1e15f7252 test-data/S2A_MSIL2A_20200306T015621_N0214_R117_T51JXN_20200306T034744.zip Binary file test-data/S2A_MSIL2A_20200306T015621_N0214_R117_T51JXN_20200306T034744.zip has changed diff -r 000000000000 -r 33a1e15f7252 test-data/S2A_Subset Binary file test-data/S2A_Subset has changed diff -r 000000000000 -r 33a1e15f7252 test-data/S2A_Subset.hdr --- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/test-data/S2A_Subset.hdr Mon Jan 09 13:37:05 2023 +0000 @@ -0,0 +1,35 @@ +ENVI +description = { + File Resize Result, x resize factor: 1.000000, y resize factor: 1.000000. + [Thu Jul 11 09:00:28 2019]} +samples = 1000 +lines = 1000 +bands = 10 +header offset = 0 +file type = ENVI Standard +data type = 2 +interleave = bil +sensor type = Unknown +byte order = 0 +x start = 998 +y start = 766 +map info = {UTM, 1.000, 1.000, 356780.000, 351500.000, 1.0000000000e+001, 1.0000000000e+001, 33, North, WGS-84, units=Meters} +coordinate system string = {PROJCS["WGS_1984_UTM_Zone_33N",GEOGCS["GCS_WGS_1984",DATUM["D_WGS_1984",SPHEROID["WGS_1984",6378137.0,298.257223563]],PRIMEM["Greenwich",0.0],UNIT["Degree",0.0174532925199433]],PROJECTION["Transverse_Mercator"],PARAMETER["false_easting",500000.0],PARAMETER["false_northing",0.0],PARAMETER["central_meridian",15.0],PARAMETER["scale_factor",0.9996],PARAMETER["latitude_of_origin",0.0],UNIT["Meter",1.0]]} +wavelength units = Nanometers +z plot range = {-32768.00, 32767.00} +data ignore value = 0 +default stretch = 0.000000 1000.000000 linear +band names = { + Resize (band 02:S2A_T33NUD_20180104_Subset), + Resize (band 03:S2A_T33NUD_20180104_Subset), + Resize (band 04:S2A_T33NUD_20180104_Subset), + Resize (band 05:S2A_T33NUD_20180104_Subset), + Resize (band 06:S2A_T33NUD_20180104_Subset), + Resize (band 07:S2A_T33NUD_20180104_Subset), + Resize (band 08:S2A_T33NUD_20180104_Subset), + Resize (band 08A:S2A_T33NUD_20180104_Subset), + Resize (band 11:S2A_T33NUD_20180104_Subset), + Resize (band 12:S2A_T33NUD_20180104_Subset)} +wavelength = { + 496.600006, 560.000000, 664.500000, 703.900024, 740.200012, 782.500000, + 835.099976, 864.799988, 1613.699951, 2202.399902} diff -r 000000000000 -r 33a1e15f7252 test-data/S2A_T33NUD_Plots.zip Binary file test-data/S2A_T33NUD_Plots.zip has changed diff -r 000000000000 -r 33a1e15f7252 val_metadata.r --- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/val_metadata.r Mon Jan 09 13:37:05 2023 +0000 @@ -0,0 +1,41 @@ +#Rscript + +############################################ +## Validate ISO 19139 metadata documen ## +############################################ + +#####Packages : ncdf4, +# geometa, +# httr +# xml +# xml2 +library(geometa) + +#####Load arguments + +args <- commandArgs(trailingOnly = TRUE) + +if (length(args) < 1) { + stop("This tool needs at least 1 argument") +}else { + input_data <- args[1] +} + +##------------------------------------------## +## Read ISO 19139 from a file or url ## +##------------------------------------------## + +# Test depuis catalogue Indores http://indores-tmp.in2p3.fr/geonetwork/srv/fre/catalog.search#/metadata/112ebeea-e79c-422c-8a43-a5a8323b446b +# +input_data <- xml2::read_xml(input_data) + +dir.create("results") +file.create("results/meta.xml") + +xml2::write_xml(input_data, file = "results/meta.xml") + +md <- geometa::readISO19139("results/meta.xml") + + +# validate iso +cat("\nValidation of metadata according to ISO 19139\n", md$validate(), file = "Metadata_validation.txt", fill = 1, append = FALSE)