diff --git a/R/deprecated functions/goa_allocate_stations.R b/R/deprecated functions/goa_allocate_stations.R index 15e6122..dc24219 100644 --- a/R/deprecated functions/goa_allocate_stations.R +++ b/R/deprecated functions/goa_allocate_stations.R @@ -106,13 +106,15 @@ goa_allocate_stations <- FUN = function(x) sapply(X = split(x = x, f = optim_df$STRATUM), - FUN = function(xx) sd(as.vector(xx))))[strata_names,] + FUN = function(xx) + stats::sd(x = as.vector(xx))))[strata_names,] strs_mean <- apply(X = dens[, spp_idx, ], MARGIN = 2, FUN = function(x) sapply(X = split(x = x, f = optim_df$STRATUM), - FUN = function(xx) mean(as.vector(xx))))[strata_names,] + FUN = function(xx) + stats::mean(x = as.vector(xx))))[strata_names,] strs_stats <- cbind(data.frame( STRATO = 1:length(strata_names), diff --git a/analysis_scripts/GOA/1A_operating_model_data.R b/analysis_scripts/GOA/1A_operating_model_data.R index 57a3da0..f0cb092 100644 --- a/analysis_scripts/GOA/1A_operating_model_data.R +++ b/analysis_scripts/GOA/1A_operating_model_data.R @@ -1,207 +1,59 @@ -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -## Project: GOA Groundfish CPUE Data Synthesis -## Author: Zack Oyafuso (zack.oyafuso@noaa.gov) -## Contributors: Lewis Barnett (lewis.barnett@noaa.gov) -## Description: Create CPUE dataset used for VAST for species of interest -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ +############################################################################### +## Project: GOA Groundfish CPUE Data Synthesis +## Author: Zack Oyafuso (zack.oyafuso@noaa.gov) +## Contributors: Lewis Barnett (lewis.barnett@noaa.gov) +## Description: Create CPUE dataset used for VAST for species of interest +############################################################################### rm(list = ls()) -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -## Import libraries -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -library(dplyr) -library(terra) -library(sumfish) - -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -## Constants used -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ - -## crs used -lonlat_crs <- "+proj=longlat +datum=WGS84 +no_defs +ellps=WGS84 +towgs84=0,0,0" -utm_crs <- "+proj=utm +zone=5N +units=km" - -## years used -start_year <- 1996 -current_year <- 2021 - ################################################## -#### Import CPUE survey data -#### Import Haul-level data -#### Import Species codes +#### Import gapindex, Connect to Oracle ################################################## -sumfish::getSQL() -GOA <- sumfish::getRacebase(year = c(start_year, current_year), - survey = 'GOA') - -data <- sumfish::sumHaul(GOA) %>% dplyr::mutate(REGION = "GOA") -species_codes <- GOA$species - -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -## Merge bathy rasters ---- -## These rasters are really dense, so they are stored in parts and then -## "puzzled" togethered using terra::merge() -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -split_bathy <- list() - -n_split_rasters <- length(grep(x = dir("data/GOA/processed_rasters/"), - pattern = "aigoa")) -for (i in 1:n_split_rasters) { - split_bathy[[i]] <- terra::rast(x = paste0("data/GOA/processed_rasters/", - "aigoa_", i, ".tif")) -} - -bathy <- do.call(what = terra::merge, args = split_bathy) -rm(split_bathy, i, n_split_rasters) - -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -## Join species names -## Select and rename columns, dropping rows with mising depths -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -species_codes <- dplyr::select(species_codes, -YEAR_ADDED) -data <- dplyr::inner_join(data, species_codes) -data <- data %>% dplyr::select(YEAR, SURVEY = REGION, HAULJOIN = HAULJOIN, - SURFACE_TEMPERATURE, GEAR_TEMPERATURE, - BOTTOM_DEPTH, - EFFORT, WEIGHT, - LATITUDE = START_LATITUDE, - LONGITUDE = START_LONGITUDE, - SPECIES_NAME, COMMON_NAME) %>% - tidyr::drop_na(BOTTOM_DEPTH, LATITUDE, LONGITUDE) - -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -## Filter to GOA survey, remove tows with 0 bottom depth, and drop 2001, -## the year when the survey was incomplete and years before 1996 when a -## different net/soak time was used -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -data <- data %>% filter(SURVEY == "GOA", - BOTTOM_DEPTH > 0, - YEAR != 2001 & YEAR >= 1996) - -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -## Sum catches of northern and southern rock sole with rock sole unid. -## (not distinguished until 1996), rename species complex -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -rock_soles <- data %>% - dplyr::filter(COMMON_NAME %in% c("rock sole unid.", - "southern rock sole", - "northern rock sole")) %>% - dplyr::group_by_at(vars(-WEIGHT, -COMMON_NAME, -SPECIES_NAME)) %>% - dplyr::summarise(WEIGHT = sum(WEIGHT)) %>% - dplyr::ungroup() %>% - dplyr::mutate(SPECIES_NAME = "Lepidopsetta spp.", - COMMON_NAME = "rock soles") - -data <- as.data.frame(rbind(data, rock_soles)) +library(gapindex) +sql_channel <- gapindex::get_connected() -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -## Sum catches of blackspooted and rougheye rocks with rougheye and -## blackspotted rockfish unid., rename species complex -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -B_R_rockfishes <- data %>% dplyr::filter( - COMMON_NAME %in% c("blackspotted rockfish", - "rougheye rockfish", - "rougheye and blackspotted rockfish unid.")) %>% - dplyr::group_by_at(vars(-WEIGHT, -COMMON_NAME, -SPECIES_NAME)) %>% - dplyr::summarise(WEIGHT = sum(WEIGHT)) %>% - dplyr::ungroup() %>% - dplyr::mutate(SPECIES_NAME = "Sebastes B_R", - COMMON_NAME = "BS and RE rockfishes") -data <- as.data.frame(rbind(data, B_R_rockfishes)) - -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -## Sum catches of sculpins -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -sculpins <- data %>% dplyr::filter( - COMMON_NAME %in% c("bigeye sculpin", "great sculpin", - "plain sculpin", "yellow Irish lord")) %>% - dplyr::group_by_at(vars(-WEIGHT, -COMMON_NAME, -SPECIES_NAME)) %>% - dplyr::summarise(WEIGHT = sum(WEIGHT)) %>% - dplyr::ungroup() %>% - dplyr::mutate(SPECIES_NAME = "sculpins", - COMMON_NAME = "sculpins") -data <- as.data.frame(rbind(data, sculpins)) - -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -## Change name of spiny dogfish to Pacific spiny dogifsh -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -data$COMMON_NAME[data$COMMON_NAME == "spiny dogfish"] <- - "Pacific spiny dogfish" - -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -## Subset data to only the species of interest -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -data <- subset(data, - COMMON_NAME %in% c( - ## Species included in the survey optimization - "arrowtooth flounder", ## Atherestes stomias - "Pacific cod", ## Gadus macrocephalus - "walleye pollock", ## Gadus chalcogrammus - "rex sole", ## Glyptocephalus zachirus - "flathead sole", ## Hippoglossoides elassodon - "Pacific halibut", ## Hippoglossus stenolepis - "southern rock sole", ## Lepidopsetta bilineata - "northern rock sole", ## Lepidopsetta polyxystra - "Pacific ocean perch", ## Sebastes alutus - "silvergray rockfish", ## Sebastes brevispinis - "northern rockfish", ## Sebastes polyspinis - "dusky rockfish", ## Sebastes variabilis - "BS and RE rockfishes", ## Sebastes aleutianus and S. melanostictus - "Dover sole", ## Microstomus pacificus - "shortspine thornyhead", ## Sebastolobus alascanus - - ## Species not included in the survey optimization, but - ## included when simulating surveys - "sablefish", - "Atka mackerel", - "shortraker rockfish", - "Pacific spiny dogfish", - "yelloweye rockfish", - "giant octopus", - "longnose skate", - "big skate", - "harlequin rockfish", - "giant grenadier", - "sculpins" - )) - -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -## Assign station depths from EFH layer -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -cpue_shape <- terra::vect(x = data[, c("LONGITUDE", "LATITUDE")], - geom = c("LONGITUDE", "LATITUDE"), - keepgeom = TRUE, - crs = lonlat_crs) -cpue_shape_aea <- terra::project(x = cpue_shape, - y = terra::crs(bathy)) -cpue_shape_aea$depth <- terra::extract(x = bathy, - y = cpue_shape_aea)$AIGOA_ba -cpue_shape_aea[, c("COMMON_NAME", "BOTTOM_DEPTH")] <- - data[, c("COMMON_NAME", "BOTTOM_DEPTH")] - -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -## Plot correlation between EFH depths and reported depth from BTS -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -plot(depth ~ BOTTOM_DEPTH, - data = as.data.frame(cpue_shape_aea)[cpue_shape_aea$COMMON_NAME == "Pacific cod", ], - xlab = "Depth recorded by the BTS", - ylab = "Depth extracted from EFH layer") -cor(cpue_shape_aea$depth, cpue_shape_aea$BOTTOM_DEPTH, use = "complete.obs") -abline(a = 0, b = 1) - -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -## Attach depths to dataset, scaled -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -data$DEPTH_EFH <- cpue_shape_aea$depth -data$DEPTH_EFH[is.na(data$DEPTH_EFH)] <- - data$BOTTOM_DEPTH[is.na(data$DEPTH_EFH)] -data$LOG10_DEPTH_EFH <- log10(data$DEPTH_EFH) -data$LOG10_BOTTOM_DEPTH <- log10(data$BOTTOM_DEPTH) +################################################## +#### Set up haul-level CPUE survey +################################################## +spp_set <- read.csv(file = "data/GOA/species_list/species_list.csv") + +## Pull Data from RACEBASE +gapindex_data <- gapindex::get_data(survey_set = "GOA", + year_set = c(1996, 1999, + seq(from = 2003, + to = format(x = Sys.Date(), + format = "%Y"), + by = 2)), + spp_codes = spp_set[,-3], + pull_lengths = FALSE, + sql_channel = sql_channel) + +## Calculate and zero-fill CPUE +gapindex_cpue <- gapindex::calc_cpue(racebase_tables = gapindex_data) + +## Format catch and effort data for VAST. Note: The `AreaSwept_km2` field set +## to 1 when using CPUE in the `Catch_KG` field. +data_geostat <- + with(gapindex_cpue, + data.frame(Hauljoin = HAULJOIN, + Species = SPECIES_CODE, + Year = YEAR, + Vessel = "missing", + AreaSwept_km2 = 1, + Catch_KG = CPUE_KGKM2, + Lat = LATITUDE_DD_START, + Lon = LONGITUDE_DD_START, + Depth_m = DEPTH_M, + LOG10_DEPTH_M = log10(x = DEPTH_M), + LOG10_DEPTH_M_CEN = scale(x = log10(x = DEPTH_M)), + Pass = 0) ) -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -## Save -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -data <- data[order(data$YEAR, data$SPECIES_NAME),] -write.csv(x = data, - file = "data/GOA/goa_vast_data_input.csv", +################################################## +#### Save +################################################## +if (!dir.exists(paths = "data/GOA/vast_data/")) + dir.create(path = "data/GOA/vast_data/") +write.csv(x = data_geostat, + file = "data/GOA/vast_data/goa_data_geostat.csv", row.names = F) +saveRDS(object = data_geostat, file = "data/GOA/vast_data/goa_data_geostat.RDS") diff --git a/analysis_scripts/GOA/1B_grid_covariate_data.R b/analysis_scripts/GOA/1B_grid_covariate_data.R index 81a4704..258bb50 100644 --- a/analysis_scripts/GOA/1B_grid_covariate_data.R +++ b/analysis_scripts/GOA/1B_grid_covariate_data.R @@ -1,87 +1,93 @@ -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -## Project: VAST covariates across goa grid -## Author: Zack Oyafuso (zack.oyafuso@noaa.gov) -## Description: Assign bathymetry value from the EFH data layer to each grid -## in the Gulf of Alaska grid. -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ +############################################################################### +## Project: VAST covariates across goa grid +## Author: Zack Oyafuso (zack.oyafuso@noaa.gov) +## Description: Assign bathymetry value from the EFH data lyaer to each grid in +## the Gulf of Alaska grid. +############################################################################### rm(list = ls()) -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -## Import packages -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ +################################################## +#### Import packages +################################################## library(terra) -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -## CRSs used -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ +################################################## +#### CRSs used +################################################## lonlat_crs <- "+proj=longlat +datum=WGS84 +no_defs +ellps=WGS84 +towgs84=0,0,0" -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -## Merge bathy rasters ---- -## These rasters are really dense, so they are stored in parts and then -## "puzzled" togethered using terra::merge() -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -split_bathy <- list() +################################################## +#### Merge together bathymetry rasters +################################################## +goa_bathy <- + terra::rast(x = "//AKC0SS-n086/AKC_PubliC/Dropbox/Zimm/GEBCO/GOA/goa_bathy") -n_split_rasters <- length(grep(x = dir("data/GOA/processed_rasters/"), - pattern = "aigoa")) -for (i in 1:n_split_rasters) { - split_bathy[[i]] <- terra::rast(x = paste0("data/GOA/processed_rasters/", - "aigoa_", i, ".tif")) -} +################################################## +#### Import Current Strata (current_survey_strata) +#### Import spatial domain outline mask (current_survey_mask) +#### Import Extrapolation grid (goa_grid) +#### Import CPUE data (data) +#### Untrawlable areas (goa_grid_nountrawl) +################################################## +current_survey_strata <- + terra::vect(x = "data/GOA/shapefiles_from_GDrive/goa_strata.shp") +current_survey_strata <- + current_survey_strata[current_survey_strata$STRATUM != 0] +current_survey_strata <- + terra::project(x = current_survey_strata, terra::crs(x = goa_bathy)) -bathy <- do.call(what = terra::merge, args = split_bathy) -rm(split_bathy, i, n_split_rasters) +goa_grid <- read.csv("data/GOA/extrapolation_grid/GOAThorsonGrid_Less700m.csv") +goa_grid <- goa_grid[, c("Id", "Shape_Area", "Longitude", "Latitude")] +goa_grid$Shape_Area <- goa_grid$Shape_Area / 1000 / 1000 #Convert to km2 +names(goa_grid) <- c( "Id", "Area_km2", "Lon", "Lat") -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -## Import spatial objects: -## Historical station polygons (historical stations) -## Create mask by dissovling inner boundaries of the historical stations -## Extrapolation grid used for VAST, 2 nmi resolution (goa_grid) -## CPUE data (data) -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -historical_stations <- terra::vect(x = "data/GOA/shapefiles_from_GDrive//goagrid.shp") -historical_stations <- terra::project(x = historical_stations, y = bathy) +goa_data_geostat = read.csv("data/GOA/vast_data/goa_data_geostat.csv") -historical_mask <- terra::aggregate(x = historical_stations) +################################################## +#### Transform extrapolation grid to aea, extract bathymetry values onto grid +################################################## +grid_shape = terra::vect(x = goa_grid[, c("Lon", "Lat", "Area_km2")], + geom = c("Lon", "Lat"), keepgeom = TRUE, + crs = lonlat_crs) +grid_shape_aea <- terra::project(x = grid_shape, terra::crs(x = goa_bathy)) +grid_shape_aea[, c("Eastings", "Northings")] <- terra::crds(x = grid_shape_aea) -vast_goa_grid <- read.csv("data/GOA/extrapolation_grid/GOAThorsonGrid.csv") -vast_goa_grid <- vast_goa_grid[, c("Id", "Shape_Area", "Longitude", "Latitude")] -vast_goa_grid$Shape_Area <- vast_goa_grid$Shape_Area / 1e6 #Convert to km2 -names(vast_goa_grid) <- c( "Id", "Area_km2", "Lon", "Lat") +grid_shape_aea$Depth_m <- + terra::extract(x = goa_bathy, y = grid_shape_aea)$GOA_bathy -data = read.csv("data/GOA/goa_vast_data_input.csv") +################################################## +#### Remove cells not already in the current GOA strata +################################################## +grid_shape_aea <- terra::intersect(x = grid_shape_aea, + y = current_survey_strata[, "STRATUM"]) -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -## Transform extrapolation grid to aea, extract bathymetry values onto grid -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -vast_goa_grid_shape <- terra::vect(x = vast_goa_grid[, c("Lon", "Lat")], - geom = c("Lon", "Lat"), - keepgeom = TRUE, - crs = lonlat_crs) +################################################## +#### Remove cells with depths outside the observed range to the range +################################################## +grid_shape_aea <- grid_shape_aea[ + (grid_shape_aea$Depth_m >= min(x = goa_data_geostat$Depth_m) & + grid_shape_aea$Depth_m <= 700), +] -vast_goa_grid_shape_aea = terra::project(x = vast_goa_grid_shape, y = bathy) -vast_goa_grid_shape_aea$Area_km2 <- vast_goa_grid$Area_km2 -vast_goa_grid_shape_aea$DEPTH_EFH <- - terra::extract(x = bathy, y = vast_goa_grid_shape_aea)$AIGOA_ba +################################################## +#### scale grid bathymetry values to standard normal, using the mean and sd +#### of the BTS data +################################################## +BTS_mean <- stats::mean(log10(x = goa_data_geostat$Depth_m)) +BTS_sd <- stats::sd(log10(x = goa_data_geostat$Depth_m)) -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -## Remove cells not already in the goa grid -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -vast_goa_grid_shape_aea <- terra::intersect(x = vast_goa_grid_shape_aea, - y = historical_mask) +grid_shape_aea$LOG10_DEPTH_M <- log10(x = grid_shape_aea$Depth_m) +grid_shape_aea$LOG10_DEPTH_M_CEN <- + (grid_shape_aea$LOG10_DEPTH_M - BTS_mean) / BTS_sd -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -## Remove cells with depths outside the observed range to the range -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -vast_goa_grid_shape_aea <- - vast_goa_grid_shape_aea[vast_goa_grid_shape_aea$DEPTH_EFH >= min(data$BOTTOM_DEPTH) & - vast_goa_grid_shape_aea$DEPTH_EFH <= max(data$BOTTOM_DEPTH),] - -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -## Save -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -if(!dir.exists("data/GOA/")) dir.create("data/GOA/") -write.csv(x = as.data.frame(vast_goa_grid_shape_aea), +################################################## +#### Save +################################################## +if (!dir.exists(paths = "data/GOA/vast_data/")) + dir.create(path = "data/GOA/vast_data/") +write.csv(as.data.frame(x = grid_shape_aea), row.names = F, - file = "data/GOA/vast_grid_goa.csv") + file = "data/GOA/vast_data/goa_interpolation_grid.csv") + +saveRDS(object = as.data.frame(x = grid_shape_aea), + file = "data/GOA/vast_data/goa_interpolation_grid.RDS") diff --git a/analysis_scripts/GOA/1C_fit_vast_models.R b/analysis_scripts/GOA/1C_fit_vast_models.R index de9378f..bdf9355 100644 --- a/analysis_scripts/GOA/1C_fit_vast_models.R +++ b/analysis_scripts/GOA/1C_fit_vast_models.R @@ -1,165 +1,151 @@ -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -## Project: Single-species VAST model runs -## Author: Zack Oyafuso (zack.oyafuso@noaa.gov) -## Description: Lewis Barnett (lewis.barnett@noaa.gov) -## Jim Thorson"s VAST wiki example -## (https://github.com/James-Thorson-NOAA/VAST/wiki/Crossvalidation) -## Description: Run single-species VAST models with and without depth -## as a smoother with 2 knots. Run 10-fold cross validation for -## each model -## -## -## NOTES: Make sure R and package versions are consistent with those -## versions speficied in the 2022 Terms of Reference (TOR) -## used for providing model-based abundance indices for stock -## assessment. -## https://docs.google.com/document/d/1t-pIruLZ-F_iNzCysWLH8cdsM0gZpuUb/edit -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ +############################################################################### +## Project: Univariate VAST model runs +## Author: Zack Oyafuso (zack.oyafuso@noaa.gov) +## Contributors: Lewis Barnett (lewis.barnett@noaa.gov) +## Jim Thorson"s VAST wiki example +## (https://github.com/James-Thorson-NOAA/VAST/wiki/Crossvalidation) +## Description: Run single-species VAST models wit and without depth +## as a covariate. Run 10-fold Cross Validation for each Model +############################################################################### rm(list = ls()) -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -## Set result directory ---- -## Model output is saved outside of repo due to size of the result outputs -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -VAST_dir <- c("C:/Users/zack.oyafuso/Desktop/VAST_Runs/") -if(!dir.exists(VAST_dir)) dir.create(VAST_dir, recursive = T) - -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -## Load packages ---- -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ +################################################## +#### Load packages, make sure versions are consistent +################################################## library(VAST) -library(effects) -library(splines) -library(units) ##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -## Package Version Preferences ---- +## Package version checks ---- +## Updated every year +## 2023 TOR is in this google doc: +## https://docs.google.com/document/d/18CeXcHhHK48hrtkiC6zygXlHj6YVrWEd/edit ##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -R_version <- "R version 4.0.2 (2020-06-22)" -current_year <- 2022 -VAST_cpp_version <- "VAST_v13_1_0" -pck_version <- c("VAST" = "3.9.0", - "FishStatsUtils" = "2.11.0", - "Matrix" = "1.4-0", - "TMB" = "1.7.22", - "DHARMa" = "0.4.5") - -{ - if(sessionInfo()$R.version$version.string == R_version) - message(paste0(sessionInfo()$R.version$version.string, - " is consistent with the ", current_year, " TOR.")) - - if(!sessionInfo()$R.version$version.string == R_version) - message(paste0("WARNING: ", sessionInfo()$R.version$version.string, - " is NOT consistent with the ", current_year, " TOR. ", - "Please update R version to ", R_version)) - - for (pck in 1:length(pck_version)) { - temp_version <- packageVersion(pkg = names(pck_version)[pck]) - - if(temp_version == pck_version[pck]) - message(paste0("The version of the '", names(pck_version)[pck], - "' package (", temp_version, ") is consistent", - " with the ", current_year, " TOR.")) - - if(!temp_version == pck_version[pck]) - message(paste0("WARNING: ", - "The version of the '", names(pck_version)[pck], - "' package (", temp_version, ") is NOT consistent", - " with the ", current_year, " TOR. Please update the '", - names(pck_version)[pck], "' package to ", - pck_version[pck])) - } +current_year <- 2023 +vast_cpp_version <- "VAST_v14_0_1" +pck_version <- c("VAST" = "3.10.0", + "FishStatsUtils" = "2.12.0", + "Matrix" = "1.5-3", + "TMB" = "1.9.2", + "DHARMa" = "0.4.6") + +for (pck in 1:length(pck_version)) { + temp_version <- packageVersion(pkg = names(pck_version)[pck]) + + if(temp_version == pck_version[pck]) + message(paste0("The version of the '", names(pck_version)[pck], + "' package (", temp_version, ") is consistent", + " with the ", current_year, " TOR.")) + + if(!temp_version == pck_version[pck]) + message(paste0("WARNING: ", + "The version of the '", names(pck_version)[pck], + "' package (", temp_version, ") is NOT consistent", + " with the ", current_year, " TOR. Please update the '", + names(pck_version)[pck], "' package to ", + pck_version[pck])) + rm(pck, temp_version) } +################################################## +#### Import CPUE dataset, species set spreadsheet +################################################## +goa_data_geostat <- read.csv(file = "data/GOA/vast_data/goa_data_geostat.csv" ) +goa_interpolation_grid <- + read.csv(file = "data/GOA/vast_data/goa_interpolation_grid.csv") -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -## Import Data ---- -## Import CPUE data for each species -## Import goa grid with depths -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -master_data <- read.csv(file = "data/GOA/goa_vast_data_input.csv" ) -spp_names <- sort(unique(master_data$COMMON_NAME)) +################################################# +## Loop over species to fit models with and without depth covariates +################################################# +spp_names <- sort(x = unique(x = goa_data_geostat$Species)) -grid_goa <- read.csv("data/GOA/vast_grid_goa.csv") -grid_goa$LOG10_DEPTH <- log10(grid_goa$DEPTH_EFH) +for (depth_in_model in c(F, T)) { ## Loop over depth covariate -- start + for (ispp in spp_names) { ## Loop over species -- start -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -## Fit models ---- -## Loop over species to fit models with and without depth covariates -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -for (ispp in spp_names) { ## Loop over species -- start - for (depth_in_model in c(F, T)) { ## Loop over covariates -- start - - ## Create directory to store model results - result_dir <- paste0(VAST_dir, ispp, ifelse(test = depth_in_model, - yes = "_depth/", - no = "/")) - - if (!dir.exists(result_dir)) dir.create(result_dir) - - ## Subset species - data <- subset(master_data, COMMON_NAME == ispp) - - ## Prepare the dataframe for catch-rate data in the VAST format - data_geostat <- data.frame(spp = data$COMMON_NAME, - HAULJOIN = data$HAULJOIN, - Year = data$YEAR, - Catch_KG = data$WEIGHT, - AreaSwept_km2 = data$EFFORT * 0.01, - Lat = data$LATITUDE, - Lon = data$LONGITUDE, - LOG10_DEPTH = log10(data$BOTTOM_DEPTH), - stringsAsFactors = T) - - ## Assign 10 fold partitions of the data + ################################################## + ## Create temporary directory to store model results within the repo + ## The temp/ folder is gitignored. + ################################################## + result_dir <- paste0(getwd(), "/temp/", ispp, ifelse(test = depth_in_model, + yes = "_depth/", + no = "/")) + + if (!dir.exists(paths = result_dir)) + dir.create(path = result_dir, recursive = TRUE) + + ################################################## + #### Subset species + ################################################## + temp_df <- subset(x = goa_data_geostat, subset = Species == ispp) + + ################################################## + #### Assign 10 fold partitions of the data + ################################################## n_fold <- 10 - years <- paste0(unique(data_geostat$Year)) - NTime <- length(unique(data_geostat$Year)) + years <- paste0(sort(x = unique(x = temp_df$Year))) + NTime <- length(x = unique(x = temp_df$Year)) - ## split data_geostat df by year, then on each split sub-df, randomly - ## assign to a fold (1 of n_fold) - set.seed(current_year) + #split data_geostat by year, then on each year-split, randomly assign + #fold numbers to the each unique station (hauljoin) + set.seed(2342) foldno <- lapply( - # Split data_geostat by Year - X = split.data.frame(data_geostat, - f = data_geostat$Year), - - # For each year split, randomly assign fold numbers so that each year is - # equally split into n_fold folds + #Split data_geostat by Year + X = split.data.frame(x = temp_df, f = temp_df$Year), + #For each year split, randomly assign fold numbers so that each year is + #equally split into n_folds folds FUN = function(x) { + unique_loc <- unique(x = x$Hauljoin) fold_no <- sample(x = 1:n_fold, - size = length(x$HAULJOIN), + size = length(unique_loc), replace = T) - return(split(x$HAULJOIN, fold_no)) + return(split(unique_loc, fold_no)) }) - ## Attach fold number to the data_geostat - for (iyear in years) { ## Loop over years -- start - for (ifold in paste(1:n_fold)) { ## Loop over folds -- start - data_geostat[data_geostat$HAULJOIN %in% foldno[[iyear]][[ifold]] , - "fold"] = as.integer(ifold) - } ## Loop over folds -- end - } ## Loop over years -- end + #Attach fold number to the data_geostat + for (iyear in years) { + for (ifold in paste(1:n_fold)) { + temp_df[temp_df$Hauljoin %in% foldno[[iyear]][[ifold]] , + "fold"] = as.integer(x = ifold) + } + } - ## VAST Settings + ################################################## + #### Spatial settings: The following settings define the spatial resolution + #### for the model, and whether to use a grid or mesh approximation + #### Stratification for results + ################################################## settings <- FishStatsUtils::make_settings( - Version = VAST_cpp_version, + Version = vast_cpp_version, n_x = 500, # Number of knots Region = "User", #User inputted extrapolation grid purpose = "index2", - bias.correct = FALSE, - fine_scale = TRUE, - ## Fields for spatial (Omega) or spatiotemporal (epsilon) variation - ## on the 1st or 2nd predictor - FieldConfig = c( "Omega1" = "IID", "Epsilon1" = "IID", - "Omega2" = "IID", "Epsilon2" = "IID"), + bias.correct = TRUE, + FieldConfig = c( + "Omega1" = 1, #Spatial random effect on occurence + "Epsilon1" = 1, #Spatiotemporal random effect on occurence + "Omega2" = 1, #Spatial random effect on positive response + "Epsilon2" = 1 #Spatiotemporal random effect on positive response + ), "Options" = c("Calculate_Range" = F, "Calculate_effective_area" = F), ObsModel = c(2, 1), max_cells = Inf, use_anisotropy = T) + ################################################## + #### Import "true" and not interpolated covariate + #### data if using depth covariates + ################################################## + n_g <- nrow(x = goa_interpolation_grid) #number of grid cells + n_t <- length(x = unique(x = temp_df$Year)) #Number of total years + n_p <- 1 #two density covariates + + X_gtp <- array(dim = c(n_g, n_t, n_p) ) + for (i in 1:n_t) X_gtp[, i, ] <- + as.matrix(x = goa_interpolation_grid[, c("LOG10_DEPTH_M_CEN")]) + + ################################################## + #### Fit the model and save output + ################################################## #### Set general arguments to FishStatsUtils::fit_model() vast_arguments <- list( @@ -168,15 +154,15 @@ for (ispp in spp_names) { ## Loop over species -- start "settings" = settings, ## Interpolation grid locations and total areas - "input_grid" = grid_goa[, c("Area_km2", "Lon", "Lat")], + "input_grid" = goa_interpolation_grid[, c("Area_km2", "Lon", "Lat")], ## Data inputs - "Lat_i" = data_geostat[, "Lat"], - "Lon_i" = data_geostat[, "Lon"], - "t_i" = data_geostat[, "Year"], - "c_i" = rep(0, nrow(data_geostat)), - "b_i" = units::as_units(data_geostat$Catch_KG, "kg"), - "a_i" = units::as_units(data_geostat$AreaSwept_km2, "km2"), + "Lat_i" = temp_df[, "Lat"], + "Lon_i" = temp_df[, "Lon"], + "t_i" = temp_df[, "Year"], + "c_i" = rep(0, nrow(x = temp_df)), + "b_i" = units::as_units(x = temp_df$Catch_KG, "kg"), + "a_i" = units::as_units(x = temp_df$AreaSwept_km2, "km2"), ## Output settings "getJointPrecision" = TRUE, @@ -188,19 +174,35 @@ for (ispp in spp_names) { ## Loop over species -- start ## Covariate data: bathy from grids come from the EFH bathymetry layer ## and bathy from data_geostat are those collected from the survey "covariate_data" = cbind( - rbind(data_geostat[, c("Lat", "Lon", "LOG10_DEPTH")], - grid_goa[, c("Lat", "Lon", "LOG10_DEPTH")]), + rbind(temp_df[, c("Lat", "Lon", "LOG10_DEPTH_M")], + goa_interpolation_grid[, c("Lat", "Lon", "LOG10_DEPTH_M")]), Year = NA)) if (depth_in_model) vast_arguments[["X1_formula"]] <- vast_arguments[["X2_formula"]] <- - ~ splines::bs(LOG10_DEPTH, + ~ splines::bs(LOG10_DEPTH_M, degree = 2, intercept = FALSE) ## Initial Fit fit <- do.call(what = FishStatsUtils::fit_model, args = vast_arguments) + ################################################## + #### Diagnostics plots + ################################################## + if(!dir.exists(paste0(result_dir, "/diagnostics"))) { + dir.create(paste0(result_dir, "/diagnostics")) + } + + plot(x = fit, + working_dir = paste0(result_dir, "diagnostics/")) + + ################################################## + #### Save original model fit and copy output from the temporary res dir + ################################################## + ## Save original model fit + saveRDS(object = fit, file = paste0(result_dir, "/fit.RDS")) + ## Plot depth effects if (depth_in_model) { @@ -209,14 +211,14 @@ for (ispp in spp_names) { ## Loop over species -- start catchability_data_full = fit$effects$catchability_data_full depth_effect_pred1 <- VAST::Effect.fit_model( fit, - focal.predictors = c("LOG10_DEPTH"), + focal.predictors = c("LOG10_DEPTH_M"), which_formula = "X1", xlevels = 100, transformation = list(link=identity, inverse=identity) ) depth_effect_pred2 <- VAST::Effect.fit_model( fit, - focal.predictors = c("LOG10_DEPTH"), + focal.predictors = c("LOG10_DEPTH_M"), which_formula = "X2", xlevels = 100, transformation = list(link=identity, @@ -235,15 +237,15 @@ for (ispp in spp_names) { ## Loop over species -- start width = 5, height = 5, onefile = TRUE ) for (ipred in 1:2) { temp <- get(paste0("depth_effect_pred", ipred)) - plot(x = temp$LOG10_DEPTH, y = temp$pred, type = "n", xaxt = "n", + plot(x = temp$LOG10_DEPTH_M, y = temp$pred, type = "n", xaxt = "n", ylim = range(temp[, c("lower", "upper")]), las = 1, ylab = "Marginal Effect", xlab = "Depth (m)", main = paste0("Depth Effect on ", c("1st", "2nd")[ipred], " Predictor\n", ispp)) - with(temp, polygon(x = c(LOG10_DEPTH, rev(LOG10_DEPTH)), + with(temp, polygon(x = c(LOG10_DEPTH_M, rev(LOG10_DEPTH_M)), y = c(lower, rev(upper)), col = "cornflowerblue", border = F)) - with(temp, lines(x = LOG10_DEPTH, y = pred, lwd = 2)) + with(temp, lines(x = LOG10_DEPTH_M, y = pred, lwd = 2)) axis(side = 1, labels = NA, tck = -0.015, at = log10(c(seq(10, 90, 10), seq(100, 1000, 100)))) axis(side = 1, labels = NA, tck = -0.03, @@ -257,14 +259,6 @@ for (ispp in spp_names) { ## Loop over species -- start file = paste0(result_dir, "depth_effect.RData")) } - ## Diagnostics plots - if(!dir.exists(paste0(result_dir, "/diagnostics"))) - dir.create(paste0(result_dir, "/diagnostics")) - plot(x = fit, working_dir = paste0(result_dir, "diagnostics/")) - - ## Save original model fit - saveRDS(object = fit, file = paste0(result_dir, "/fit.RDS")) - ################################################## #### 10-fold Cross Validation #### First, save MLE parameter values to the VAST arguments to be used @@ -276,25 +270,28 @@ for (ispp in spp_names) { ## Loop over species -- start for (fI in 1:n_fold) { ## Loop over folds -- start ## Create directory for CV run - if (!dir.exists(paste0(result_dir, "CV_", fI))){ - dir.create(paste0(result_dir, "CV_", fI)) + if (!dir.exists(paths = paste0(result_dir, "CV_", fI))){ + dir.create(path = paste0(result_dir, "CV_", fI)) file.copy(from = paste0(result_dir, "Kmeans_knots-", settings$n_x, ".RData"), to = paste0(result_dir, "CV_", fI, "/")) } ## Update which indices are withheld for prediction - PredTF_i <- ifelse( test = data_geostat$fold == fI, + PredTF_i <- ifelse( test = temp_df$fold == fI, yes = TRUE, no = FALSE ) vast_arguments$PredTF_i <- PredTF_i vast_arguments$working_dir <- paste0(result_dir, "CV_", fI, "/") + ## Turn bias correction off for Cross Validation runs + vast_arguments$settings$bias.correct <- FALSE + ## Fit CV run fit_CV <- do.call(what = FishStatsUtils::fit_model, args = vast_arguments) ## Save predicted and observed CPUEs - obs_cpue <- with(data_geostat[PredTF_i, ], Catch_KG / AreaSwept_km2) + obs_cpue <- with(temp_df[PredTF_i, ], Catch_KG / AreaSwept_km2) pred_cpue <- fit_CV$Report$D_i[PredTF_i] cv_performance <- @@ -316,19 +313,19 @@ for (ispp in spp_names) { ## Loop over species -- start covariate_data_full = fit$effects$covariate_data_full catchability_data_full = fit$effects$catchability_data_full depth_effect_pred1 <- - VAST::Effect.fit_model( fit, - focal.predictors = c("LOG10_DEPTH"), - which_formula = "X1", - xlevels = 100, - transformation = list(link=identity, - inverse=identity) ) + VAST::Effect.fit_model(fit, + focal.predictors = c("LOG10_DEPTH_M"), + which_formula = "X1", + xlevels = 100, + transformation = list(link=identity, + inverse=identity) ) depth_effect_pred2 <- - VAST::Effect.fit_model( fit, - focal.predictors = c("LOG10_DEPTH"), - which_formula = "X2", - xlevels = 100, - transformation = list(link=identity, - inverse=identity) ) + VAST::Effect.fit_model(fit, + focal.predictors = c("LOG10_DEPTH_M"), + which_formula = "X2", + xlevels = 100, + transformation = list(link=identity, + inverse=identity) ) ## Save a reduced form of the predicted effects depth_effect_pred1 <- @@ -344,5 +341,70 @@ for (ispp in spp_names) { ## Loop over species -- start } } ## Loop over folds -- end - } ## Loop over covariates -- end -} ## Loop over species -- end + + ################################################## + #### Prediction Grid: df of the grid to simulate data onto + ################################################## + grid_df <- data.frame() + for (itime in sort(x = unique(x = temp_df$Year))) { + grid_df <- + rbind(grid_df, + data.frame( + Species = ispp, + Year = rep(itime, nrow(x = goa_interpolation_grid)), + Catch_KG = mean(temp_df$Catch_KG), + AreaSwept_km2 = goa_interpolation_grid$Area_km2, + Lat = goa_interpolation_grid$Lat, + Lon = goa_interpolation_grid$Lon, + LOG10_DEPTH_M_CEN = goa_interpolation_grid$LOG10_DEPTH_M_CEN, + stringsAsFactors = T) + ) + } + + ################################################### + ## Add New Points: set catch to NAs? + ################################################### + data_geostat_with_grid <- rbind(temp_df[, names(x = grid_df)], + grid_df) + + ################################################## + #### Fit the model and save output + ################################################## + pred_TF <- rep(1, nrow(x = data_geostat_with_grid)) + pred_TF[1:nrow(x = temp_df)] <- 0 + + vast_arguments$Lat_i <- data_geostat_with_grid[, "Lat"] + vast_arguments$Lon_i <- data_geostat_with_grid[, "Lon"] + vast_arguments$t_i <- data_geostat_with_grid[, "Year"] + vast_arguments$a_i <- data_geostat_with_grid[, "AreaSwept_km2"] + vast_arguments$b_i <- data_geostat_with_grid[, "Catch_KG"] + vast_arguments$c_i <- rep(x = 0, nrow(x = data_geostat_with_grid)) + vast_arguments$PredTF_i <- pred_TF + + ## Fit CV run and save model fit + vast_arguments$settings$bias.correct <- TRUE + fit_sim <- do.call(what = FishStatsUtils::fit_model, args = vast_arguments) + saveRDS(object = "fit_sim", + file = paste0(result_dir, "/fit_sim.RDS")) + + ################################################## + #### Simulate 1000 iterations of data + ################################################## + sim_data <- array(data = NA, dim = c(n_g, n_t, 1000)) + + for (isim in 1:1000) { ## Loop over replicates -- start + Sim1 <- FishStatsUtils::simulate_data(fit = fit_sim, + type = 1, + random_seed = isim) + sim_data[, , isim] <- matrix(data = Sim1$b_i[pred_TF == 1] * 0.001, + nrow = n_g, + ncol = n_t) + if(isim%%100 == 0) print(paste("Done with", ispp, "Iteration", isim)) + } ## Loop over replicates -- end + + ## Save simulated data + saveRDS(object = sim_data, + file = paste0(result_dir, "/simulated_data.RDS")) + + } ## Loop over species -- start +} ## Loop over depth covariate -- end diff --git a/analysis_scripts/GOA/1D_vast_cross_val_results.R b/analysis_scripts/GOA/1D_vast_cross_val_results.R index 3a30f25..3b7501e 100644 --- a/analysis_scripts/GOA/1D_vast_cross_val_results.R +++ b/analysis_scripts/GOA/1D_vast_cross_val_results.R @@ -1,26 +1,22 @@ -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ +############################################################################### ## Project: Synthesize the Cross Validation ## Author: Zack Oyafuso (zack.oyafuso@noaa.gov) ## Description: Loop through every CV fold and extract performance metrics ## Maximum Gradient, RRMSE, Predictive Joint Negative LogLike. -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ - -## Restart R Session before running +############################################################################### rm(list = ls()) -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -## Import Libraries ---- -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ +################################################## +#### Import Libraries +################################################## library(tidyr) -library(VAST) -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -## Set constants ---- -## Set VAST_dir to the external drive that the VAST runs are stored -## Import the VAST data input -##~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -VAST_dir <- "G:/Oyafuso/VAST_Runs_GOA_2023/" -data_df <- read.csv("data/GOA/goa_vast_data_input.csv") +################################################## +#### Set VAST_dir to the external drive that the VAST runs are stored +#### Import the VAST data input +################################################## +VAST_dir <- "temp/" +data_df <- read.csv("data/GOA/vast_data/goa_data_geostat.csv") ################################################## #### Result object @@ -32,97 +28,110 @@ cross_val_results <- data.frame() #### synthesize RRMSE, pred_jnll, maximum gradient ################################################## -spp_names <- sort(unique(data_df$COMMON_NAME)) +spp_names <- sort(x = unique(x = data_df$Species)) for (ispp in spp_names){ ## Loop through species -- start + mean_obs_cpue <- with(subset(data_df, Species == ispp), + mean(Catch_KG / AreaSwept_km2)) + for (depth_in_model in c("", "_depth")) { ## Loop through depth models -- start for (icv in 1:10) { ## Loop through cv folds -- start ## Only go through CV folds where a model run was successful fit_file <- paste0(VAST_dir, ispp, depth_in_model, - "/CV_", icv, "/", "crossval_fit_performance.RDS") + "/CV_", icv, "/", "fit.RDS") if(file.exists(fit_file)) { ## Load performance metrics - cv_performance <- readRDS(paste0(VAST_dir, ispp, depth_in_model, - "/CV_", icv, "/", "crossval_fit_performance.RDS")) + cv_performance <- + readRDS(paste0(VAST_dir, ispp, depth_in_model, + "/CV_", icv, "/", "crossval_fit_performance.RDS")) load(paste0(VAST_dir, ispp, depth_in_model, "/CV_", icv, "/", "parameter_estimates.RData")) - ## Record results + ## rbind the rrmse, max gradient, and pred_jnll + rmse <- with(cv_performance$cpues, + sqrt(mean((pred_cpue - obs_cpue)^2, na.rm = TRUE)) ) + rrmse <- rmse / mean_obs_cpue + cross_val_results <- rbind(cross_val_results, data.frame(spp_name = ispp, depth_in_model = ifelse(depth_in_model == "", F, T), cv_fold = icv, max_gradient = parameter_estimates$max_gradient, + rrmse = rrmse, pred_jnll = cv_performance$prednll )) } ## Loop through depth models -- start } ## Loop through cv folds -- end } - print(paste("Done with", ispp)) + } ## Loop through species --end ################################################## #### Synthesize Cross Validation Results ################################################## -converged <- - tidyr::spread(data = aggregate(max_gradient ~ depth_in_model + spp_name, - FUN = function(x) sum(x < 1e4), - data = cross_val_results), - key = depth_in_model, - value = max_gradient) +pred_jnll <- spread(data = aggregate(pred_jnll ~ depth_in_model + spp_name, + FUN = function(x) round(sum(x, na.rm = T)), + data = cross_val_results), + key = depth_in_model, + value = pred_jnll) -pred_jnll <- - tidyr::spread(data = aggregate(pred_jnll ~ depth_in_model + spp_name, - FUN = function(x) round(mean(x, na.rm = T)), - data = cross_val_results, - subset = max_gradient < 1e-4), - key = depth_in_model, - value = pred_jnll) +################################################## +#### Save +################################################## +save(list = c("cross_val_results", "pred_jnll"), + file = "data/GOA/vast_data/prednll_VAST_models.RData") ################################################## #### Synthesize the densities and abundance indices for the best models ################################################## -fit <- readRDS(paste0(VAST_dir, "arrowtooth flounder/fit.RDS")) -year_idx <- 1 + as.integer(names(table(fit$data_list$t_i))) -years <- (1996:2021)[year_idx] -n_years <- length(year_idx) -n_cells <- dim(fit$Report$D_gct)[1] -n_spp <- nrow(pred_jnll) +fit <- readRDS(file = paste0(VAST_dir, "arrowtooth flounder/fit.RDS")) +year_idx <- 1 + as.integer(x = names(table(fit$data_list$t_i))) +n_years <- length(x = year_idx) +n_cells <- dim(x = fit$Report$D_gct)[1] +n_spp <- nrow(x = pred_jnll) spp_names <- pred_jnll$spp_name D_gct <- array(dim = c(n_cells, n_spp, n_years), - dimnames = list(NULL, - spp_names, - paste0("year_", years))) + dimnames = list(NULL, spp_names, NULL)) + +index <- data.frame() -for(irow in 1:nrow(pred_jnll)) { ## Loop over species -- start +for (irow in 1:nrow(x = pred_jnll)) { ## Loop over species -- start ## Extract file name of best model ispp <- pred_jnll$spp_name[irow] - depth_in_model <- c(FALSE, TRUE)[which.min(pred_jnll[irow, 2:3])] - if (irow == 19) depth_in_model <- FALSE + depth_in_model <- c(FALSE, TRUE)[which.min(x = pred_jnll[irow, 2:3])] filename <- paste0(VAST_dir, ispp, ifelse(test = depth_in_model, yes = "_depth/", - no = "/"), "fit.RDS") + no = "/"), + "fit.RDS") + ## Load data + fit <- readRDS(file = filename) - - ## Load data, extract predicted density - fit <- readRDS(filename) + ## Extract grid specific density and abundance D_gct[, irow, ] <- fit$Report$D_gct[, 1, year_idx] - print(paste(ispp, ifelse(depth_in_model, "with Depth", "without Depth"))) + ## Rbind abundance index table + temp_index <- read.csv(paste0(VAST_dir, ispp, + ifelse(test = depth_in_model, + yes = "_depth/", + no = "/"), + "diagnostics/Index.csv" )) + + index <- rbind(index, data.frame(Species_Name = ispp, + temp_index[year_idx, ])) + + print(paste0(ispp, ifelse(depth_in_model, " with Depth", " without Depth"))) } ## Loop over species -- end ################################################## #### Save ################################################## -saveRDS(object = D_gct, file = "data/GOA/VAST_fit_D_gct.RDS") -save(list = c("converged", "cross_val_results", "pred_jnll"), - file = "data/GOA/prednll_VAST_models.RData") +saveRDS(object = D_gct, file = "data/GOA/vast_data/VAST_fit_D_gct.RDS") diff --git a/data/GOA/vast_data/VAST_fit_D_gct.RDS b/data/GOA/vast_data/VAST_fit_D_gct.RDS new file mode 100644 index 0000000..1af89a8 Binary files /dev/null and b/data/GOA/vast_data/VAST_fit_D_gct.RDS differ diff --git a/data/GOA/vast_data/goa_interpolation_grid.RDS b/data/GOA/vast_data/goa_interpolation_grid.RDS new file mode 100644 index 0000000..60677f7 Binary files /dev/null and b/data/GOA/vast_data/goa_interpolation_grid.RDS differ diff --git a/data/GOA/vast_data/goa_interpolation_grid.csv b/data/GOA/vast_data/goa_interpolation_grid.csv new file mode 100644 index 0000000..85a2218 --- /dev/null +++ b/data/GOA/vast_data/goa_interpolation_grid.csv @@ -0,0 +1,21672 @@ +"Lon","Lat","Area_km2","Eastings","Northings","Depth_m","STRATUM","LOG10_DEPTH_M","LOG10_DEPTH_M_CEN" +-139.56222,59.9878988,13.30186149,796569.974883758,1197867.81562188,236.789184570312,40,2.37436186194995,0.928943872752691 +-139.57658,59.9555571,13.46937338,796569.570130497,1194163.72965625,248.064376831055,40,2.39456440209367,1.00232526493372 +-141.41919,60.1103808,13.719616,692857.631962391,1190459.74016324,139.852035522461,40,2.14566879183546,0.0982653665959567 +-139.65583,59.9303277,10.04651445,792865.942818901,1190459.81377674,154.556427001953,40,2.18908706927282,0.255972943058614 +-139.5909,59.9232135,10.87882096,796569.815905908,1190459.77966651,213.236083984375,40,2.3288606982405,0.763670658834868 +-141.43176,60.0778532,9.973453481,692858.00696797,1186755.81328751,58.0114860534668,40,1.76351399073142,-1.28982994885378 +-141.36618,60.0716066,13.54029918,696561.777444381,1186755.76769543,146.413330078125,40,2.16558061849716,0.170590804432417 +-141.30062,60.0653279,7.136037136,700265.816254933,1186755.77595068,23,40,1.36172783601759,-2.74923194396041 +-139.73497,59.905051,6.989962932,789161.723633616,1186755.7595599,12.5135107040405,40,1.09737916944527,-3.70942175357246 +-139.67007,59.8979754,13.719616,792865.734428912,1186755.76623231,257.625701904297,40,2.41098918802938,1.06198477555287 +-141.3133,60.0328111,11.28212075,700265.633334029,1183051.73991326,110.442344665527,40,2.04313561803687,-0.274164386521998 +-139.74912,59.8726901,11.65393824,789161.615218291,1183051.7419664,66.9906158447266,40,1.82601397027859,-1.06281218386823 +-139.68428,59.8656213,13.719616,792865.645335976,1183051.74825797,255.896118164062,40,2.40806369787345,1.05135856028853 +-141.39138,60.0065593,10.64797415,696561.991052483,1179347.81186354,97.3981399536133,40,1.988550663084,-0.472432523008082 +-141.32595,60.0002929,13.719616,700265.722800634,1179347.76463675,31.6490268707275,40,1.50036036107785,-2.24567904327943 +-139.76324,59.8403273,11.67567262,789161.639194819,1179347.74405004,42.2607421875,40,1.62593711990762,-1.78954841203423 +-139.69846,59.8332653,13.719616,792865.682535221,1179347.75049131,208.431838989258,40,2.31896406031454,0.727723245106066 +-139.63371,59.8261718,12.57061608,796569.594910245,1179347.73635541,49.3022918701172,40,1.69286710839305,-1.54643959013451 +-146.16845,60.3395645,13.24068806,429873.562999291,1175643.75377178,15.1065673828125,41,1.17916579219731,-3.41234939551079 +-146.1016,60.3356515,13.719616,433577.641014293,1175643.75722937,15.6146430969238,41,1.19353206203353,-3.36016700292401 +-146.03476,60.3317055,13.719616,437282.049767836,1175643.81187771,16.7240180969238,41,1.22334062882515,-3.25189378012479 +-145.96795,60.3277263,13.719616,440985.706456457,1175643.76325785,18.7052783966064,41,1.2719641763252,-3.07527917706245 +-145.90115,60.3237141,13.719616,444689.708331636,1175643.76472342,14.7202920913696,41,1.16791642769248,-3.45321029828066 +-145.83437,60.3196688,13.719616,448393.517607753,1175643.73824357,11.3429679870605,41,1.05472670638683,-3.86434767362572 +-145.63411,60.3073348,13.719616,459506.040457576,1175643.81281954,12.1690263748169,41,1.08525583238295,-3.75345717412771 +-141.46935,59.9802618,12.5689176,692857.571164596,1175643.73889367,60.8523216247559,40,1.78427715199232,-1.21441222075792 +-141.40395,59.9740335,13.719616,696561.702822529,1175643.76285254,30.0403366088867,40,1.47770479472904,-2.32797052680074 +-139.77733,59.8079627,13.71291499,789161.797788977,1175643.77829256,38.6919937133789,40,1.58762110853775,-1.92872310180805 +-139.71261,59.8009075,13.719616,792865.848239813,1175643.78541403,54.5700492858887,40,1.73695434602393,-1.38630215930869 +-139.64792,59.7938208,13.719616,796569.763906979,1175643.76806745,26.7990493774414,40,1.42811938889991,-2.50807887385599 +-146.30997,60.3143951,13.719616,422465.840599096,1171939.78368099,16.0996646881104,41,1.20681683096229,-3.31191293032417 +-146.24316,60.3105522,13.719616,426169.623172579,1171939.75455301,23.2630958557129,41,1.36666751020262,-2.73128963739702 +-146.17636,60.3066763,13.719616,429873.72016079,1171939.77240141,32.9886741638184,41,1.51836486131957,-2.1802815594055 +-146.10958,60.3027672,13.719616,433577.594512885,1171939.75023898,39.8850898742676,41,1.60081057499711,-1.88081519497912 +-146.04281,60.2988251,13.719616,437281.797737351,1171939.77498179,45.1431694030762,41,1.65459204667676,-1.68546553907832 +-145.97606,60.29485,13.719616,440985.79012406,1171939.78077366,48.1520042419434,41,1.68261436857584,-1.5836804675739 +-145.90933,60.2908418,13.719616,444689.580228748,1171939.7554042,47.8278427124023,41,1.67968079234533,-1.59433605376912 +-145.84261,60.2868005,13.719616,448393.722188113,1171939.76530414,33.6942672729492,41,1.52755601649419,-2.1468966603944 +-145.77591,60.2827263,13.719616,452097.673550448,1171939.76519878,39.6194076538086,41,1.59790797815343,-1.89135825519901 +-145.70922,60.278619,13.719616,455801.991162636,1171939.8004673,34.6884918212891,41,1.5401854180914,-2.10102306900324 +-145.64256,60.2744787,13.719616,459505.587013247,1171939.74446251,26.2014598846436,41,1.41832548987629,-2.54365311056688 +-145.57591,60.2703055,13.719616,463209.560684907,1171939.74508297,18.8254127502441,41,1.27474450695446,-3.06518022263162 +-145.50927,60.2660993,13.719616,466913.920742193,1171939.79190208,12.8428783416748,41,1.1086623685783,-3.66843795377563 +-145.44266,60.2618601,13.719616,470617.580531471,1171939.74387931,13.0777139663696,41,1.11653183431243,-3.63985380806012 +-145.37606,60.257588,12.07622631,474321.639589376,1171939.75230821,13,41,1.11394335230684,-3.64925591353076 +-142.92521,60.0764843,11.99534937,611369.895594928,1171939.79032762,13,40,1.11394335230684,-3.64925591353076 +-142.85936,60.0709706,13.719616,615073.95904081,1171939.80207985,30.6666526794434,40,1.48666637454192,-2.29541951103082 +-142.79354,60.0654245,13.719616,618777.591121812,1171939.73825143,36.7448654174805,40,1.56519666106244,-2.01017509561291 +-142.72773,60.0598461,13.719616,622481.890543768,1171939.79533465,41.5651588439941,40,1.61872944452607,-1.81572874629539 +-142.66195,60.0542353,13.719616,626185.772120918,1171939.7750927,36.818042755127,40,1.56606069771386,-2.00703666787435 +-142.59619,60.0485921,13.719616,629889.789526932,1171939.77041109,32.0078239440918,40,1.50525614958315,-2.22789614203101 +-142.53045,60.0429167,13.719616,633593.945675674,1171939.80305197,37.1330490112305,40,1.56976061080405,-1.99359752747045 +-142.46474,60.0372089,13.719616,637297.704208853,1171939.7547544,39.6785163879395,40,1.59855542516115,-1.88900654286719 +-142.39905,60.0314689,13.719616,641001.614896661,1171939.74215204,38.5664329528809,40,1.58620947240196,-1.9338505671743 +-142.33338,60.0256966,13.719616,644705.686369736,1171939.75399764,40.5447006225586,40,1.60793409798536,-1.85494052622991 +-142.26773,60.0198921,13.719616,648409.923365953,1171939.80108661,27.4933967590332,40,1.43922839944958,-2.46772777671231 +-142.20211,60.0140553,13.719616,652113.787616158,1171939.77401381,24,40,1.38021124171161,-2.68209493879053 +-142.13651,60.0081863,13.719616,655817.830736223,1171939.78068055,18,40,1.25527250510331,-3.13590809121766 +-142.07093,60.0022851,13.719616,659522.059380396,1171939.82091443,13,40,1.11394335230684,-3.64925591353076 +-141.54718,59.9539186,13.22835432,689154.018647325,1171939.82430297,65.1899642944336,40,1.81418074317035,-1.10579384226464 +-141.48182,59.9477284,13.719616,692858.010874374,1171939.82251147,61.6304092407227,40,1.78979505155994,-1.194369634563 +-141.41649,59.9415061,13.6905033,696561.705670215,1171939.75502626,27.319751739502,40,1.43647674849946,-2.47772255836253 +-139.85608,59.7826131,13.719616,785457.901717695,1171939.79995398,41.3418006896973,40,1.6163893888991,-1.82422849625092 +-139.7914,59.7755963,13.719616,789161.548701622,1171939.7274153,56.2225227355957,40,1.7499103287415,-1.33924233207286 +-139.72674,59.7685479,13.719616,792865.600148678,1171939.735192,82.3012466430664,40,1.91540641365825,-0.738113314369726 +-139.6621,59.761468,13.719616,796570.059906254,1171939.83455153,134.906860351562,40,2.13003403519504,0.0414754678741039 +-139.5975,59.7543566,13.46457192,800273.840357835,1171939.7848392,95.460823059082,40,1.97982517451458,-0.504125987994609 +-146.45128,60.2890773,12.47307421,415057.660610844,1168235.7552194,12,41,1.07918124604762,-3.77552180555717 +-146.3845,60.2853045,13.719616,418761.725097919,1168235.77103625,26.578649520874,41,1.42453291037148,-2.52110598755415 +-146.31774,60.2814985,13.719616,422465.542787475,1168235.74498327,35.2218971252441,41,1.54681274427282,-2.07695072868509 +-146.25099,60.2776595,13.719616,426169.665823938,1168235.76225277,49.5721664428711,41,1.69523789920825,-1.53782820120263 +-146.18426,60.2737874,13.719616,429873.555261291,1168235.74749664,58.8743553161621,41,1.76992616456725,-1.26653910326541 +-146.11754,60.2698823,13.719616,433577.764482407,1168235.77594384,71.2385025024414,41,1.85271478162554,-0.965827215885794 +-146.05084,60.2659441,13.719616,437281.754555761,1168235.77116914,76.5356292724609,41,1.88386365729989,-0.852685608662308 +-145.98416,60.2619729,13.719616,440985.53136559,1168235.74314758,78.4332504272461,41,1.89450021339548,-0.814050600947763 +-145.91749,60.2579687,13.719616,444689.649573789,1168235.75772534,90.0687942504883,41,1.95457434888937,-0.595844193968552 +-145.85084,60.2539315,13.719616,448393.568901361,1168235.7479615,88.7024307250977,41,1.94793552102713,-0.61995831167432 +-145.7842,60.2498613,13.719616,452097.844002139,1168235.78085326,78.807991027832,41,1.89657025661819,-0.806531613113715 +-145.71758,60.2457581,13.719616,455801.934589014,1168235.78837964,69.1623306274414,41,1.83986961967393,-1.01248451046828 +-145.65098,60.241622,13.719616,459505.846436862,1168235.78059339,55.2975807189941,41,1.74270613124368,-1.36541003366764 +-145.5844,60.2374529,13.719616,463209.588098842,1168235.74537046,42.67578125,41,1.63018148033061,-1.77413168351686 +-145.51783,60.2332509,13.719616,466913.712787714,1168235.76310269,33.3692016601562,41,1.52334581652185,-2.16218930840465 +-145.45128,60.229016,13.719616,470617.680166415,1168235.76360442,26.9400081634521,41,1.43039772298837,-2.49980331414544 +-145.38474,60.2247481,13.719616,474322.046277319,1168235.80623076,23.6511268615723,41,1.37385183759408,-2.70519410970002 +-145.31823,60.2204474,13.719616,478025.72042399,1168235.7699174,19.3607425689697,41,1.2869220103805,-3.02094805438269 +-145.25173,60.2161137,13.719616,481729.807566608,1168235.77494574,15.1856098175049,41,1.18143223682456,-3.40411702171694 +-145.18525,60.2117472,13.27293952,485433.764424167,1168235.77114493,13.2709655761719,41,1.12290252264948,-3.61671364964449 +-144.98591,60.1984505,13.719616,496546.025022072,1168235.80295237,19,41,1.27875360095283,-3.05061804892018 +-144.91951,60.1939527,13.719616,500249.533031598,1168235.74493578,25,41,1.39794000867204,-2.61769899689636 +-144.85311,60.189422,13.719616,503954.042590363,1168235.81439914,22,41,1.34242268082221,-2.81935377786993 +-144.78674,60.1848585,13.719616,507657.916834374,1168235.79561984,22,41,1.34242268082221,-2.81935377786993 +-144.72039,60.1802622,13.719616,511361.71028222,1168235.76311658,21,41,1.32221929473392,-2.8927382427631 +-144.65405,60.1756332,13.719616,515065.975879257,1168235.80472956,13,41,1.11394335230684,-3.64925591353076 +-143.06792,60.054743,12.37304513,603961.972868774,1168235.80728175,34.7670478820801,40,1.54116781570618,-2.09745472046215 +-143.00209,60.0492994,13.719616,607666.018085794,1168235.80840979,67.0783538818359,40,1.82658239637879,-1.06074749802737 +-142.93629,60.0438235,13.719616,611369.613108952,1168235.74330701,69.1346817016602,40,1.83969596767878,-1.01311526407989 +-142.8705,60.0383152,13.719616,615073.86148949,1168235.7841405,71.6481857299805,40,1.85520519770009,-0.95678131386752 +-142.80474,60.0327746,13.719616,618777.673190663,1168235.75691732,74.7351608276367,40,1.87352497344546,-0.890238659375743 +-142.739,60.0272016,13.719616,622481.604306652,1168235.74233994,74.8544006347656,40,1.87421733728049,-0.887723796306604 +-142.67328,60.0215963,13.719616,626185.659705216,1168235.75111858,52.8938446044922,40,1.7234051349871,-1.43551676112433 +-142.60758,60.0159587,13.719616,629889.84611426,1168235.7829526,64.5751266479492,40,1.81006526660612,-1.12074242781988 +-142.54191,60.0102888,13.719616,633593.62278794,1168235.74215257,65.2975158691406,40,1.81489665960822,-1.10319342941941 +-142.47626,60.0045867,13.719616,637297.541981072,1168235.73375485,65.9027252197266,40,1.81890337397819,-1.08863989919752 +-142.41063,59.9988523,13.719616,641001.612314604,1168235.74648742,65.8595123291016,40,1.81861851056107,-1.08967460443664 +-142.34502,59.9930856,13.719616,644705.840495004,1168235.78011363,55.9503135681152,40,1.74780252483256,-1.34689847749725 +-142.27944,59.9872868,13.719616,648409.681827921,1168235.75879635,51.3063316345215,40,1.71017096402513,-1.48358704746665 +-142.21388,59.9814557,13.719616,652113.694360864,1168235.75682379,48.8502311706543,40,1.68886662324214,-1.56097049405475 +-142.14834,59.9755925,13.719616,655817.880813541,1168235.79601847,43.2008247375488,40,1.63549203791555,-1.75484222258432 +-142.08283,59.969697,13.719616,659521.70432912,1168235.75487864,43.0578918457031,40,1.63405276254759,-1.76007008153083 +-142.01734,59.9637695,13.719616,663225.713034419,1168235.76444583,31.1506290435791,40,1.49346682105608,-2.27071834825068 +-141.95187,59.9578098,13.719616,666929.917540862,1168235.8025607,25.7956886291504,40,1.41154712607822,-2.56827406261911 +-141.88643,59.9518179,13.719616,670633.777015493,1168235.76810892,22.953426361084,40,1.36084752380105,-2.75242948919701 +-141.82101,59.945794,13.719616,674337.841477785,1168235.7828324,20.1086044311523,40,1.30338193092091,-2.96116092485086 +-141.75562,59.939738,13.0384021,678041.572068854,1168235.73352666,12.8701362609863,40,1.10958314496819,-3.66509343111179 +-141.69025,59.9336499,13.27368292,681745.522843309,1168235.72108257,15.4694366455078,40,1.1894744981724,-3.37490523301166 +-141.6249,59.9275298,13.719616,685449.698309836,1168235.75641387,23.2188873291016,40,1.36584140410154,-2.73429029055028 +-141.55958,59.9213777,13.719616,689153.557542462,1168235.73568302,67.190673828125,40,1.82730899647549,-1.05810827908381 +-141.49428,59.9151935,12.18513018,692857.656639884,1168235.75050875,44.3079948425293,40,1.64648209648773,-1.71492319297512 +-139.99939,59.7641636,11.82073163,778050.036169811,1168235.82350124,17.7659587860107,40,1.24958865028511,-3.15655347425103 +-139.93471,59.7572166,13.719616,781753.997236504,1168235.81603062,52.2735824584961,40,1.71828226456383,-1.45412448871443 +-139.87006,59.7502381,13.719616,785457.797219774,1168235.7792525,73.4362335205078,40,1.86591039418437,-0.917896984669326 +-139.80543,59.743228,13.719616,789161.992181984,1168235.81969666,60.5171203613281,40,1.78187825443147,-1.22312570141248 +-139.74083,59.7361864,13.719616,792866.038519742,1168235.82922375,66.3587951660156,40,1.82189849221819,-1.077760774858 +-139.67626,59.7291133,13.719616,796569.942442624,1168235.80649021,183.102386474609,40,2.26269400473862,0.523334342181446 +-139.61172,59.7220088,11.62276835,800273.707750155,1168235.76108778,17.3468399047852,40,1.23922037037107,-3.19421402630053 +-146.85949,60.2780926,9.918259418,392833.590684858,1164531.75871042,326.976257324219,41,2.51451621844795,1.4380244995895 +-146.79268,60.274522,11.48501214,396538.008035261,1164531.80132009,225.336807250977,41,2.35283213659905,0.850741765082795 +-146.7259,60.2709183,12.29981065,400241.583388338,1164531.75400225,173,41,2.2380461031288,0.433806128323048 +-146.52562,60.2599086,11.590031,411353.906418329,1164531.78600972,16,41,1.20411998265592,-3.32170865313004 +-146.45889,60.2561726,13.719616,415058.021320212,1164531.80460434,42.787841796875,41,1.6313203813812,-1.7699948698264 +-146.39218,60.2524035,13.719616,418761.878521087,1164531.789388,60.3557357788086,41,1.78071854864576,-1.22733808383915 +-146.32548,60.2486013,13.719616,422466.033294334,1164531.80275257,68.525032043457,41,1.83584924729498,-1.02708765047714 +-146.2588,60.2447661,13.719616,426169.943556446,1164531.79210393,84.2510147094727,41,1.92557514016736,-0.701177597245117 +-146.19214,60.2408979,13.719616,429873.616513482,1164531.75625203,88.4092330932617,41,1.94649762329429,-0.62518116665689 +-146.12549,60.2369967,13.719616,433577.607393791,1164531.75931166,99.8036270141602,41,1.9991463244899,-0.43394605647899 +-146.05885,60.2330624,13.719616,437281.924729803,1164531.79069739,97.46142578125,140,1.98883276046617,-0.471407864797455 +-145.99223,60.2290952,13.719616,440986.025032495,1164531.80675309,103.777465820312,140,2.01610306129346,-0.372354348473929 +-145.92563,60.225095,13.719616,444689.916815239,1164531.79525431,111.36009979248,140,2.04672961144846,-0.261109976623265 +-145.85905,60.2210618,13.719616,448393.607264374,1164531.75509994,113.713966369629,140,2.05581380808934,-0.228113581535701 +-145.79248,60.2169956,13.719616,452097.651588371,1164531.75328218,109.671981811523,140,2.04009569139577,-0.285206267763921 +-145.72592,60.2128966,13.719616,455802.05418586,1164531.81260322,104.93675994873,41,2.02092765069412,-0.354830062695818 +-145.65939,60.2087646,13.719616,459505.728913772,1164531.77310553,95.9687423706055,41,1.9821298035973,-0.495754917359551 +-145.59287,60.2045996,13.719616,463209.77899446,1164531.77158324,80.5796051025391,41,1.90622513470527,-0.771462340124865 +-145.52637,60.2004018,13.719616,466913.660721332,1164531.7605762,64.2560729980469,41,1.80791418017298,-1.12855578772626 +-145.45988,60.1961711,13.719616,470617.930649826,1164531.79885324,51.0755195617676,41,1.70821279315394,-1.49069968298844 +-145.39341,60.1919074,13.719616,474322.049323268,1164531.80459317,43.4139862060547,41,1.63762966392701,-1.7470777547715 +-145.32696,60.187611,13.719616,478026.019525544,1164531.81010194,36.1278266906738,41,1.55784183688946,-2.03688991628503 +-145.26053,60.1832816,13.719616,481729.852708332,1164531.78116183,29.5658321380615,41,1.47079010683868,-2.35308664686694 +-145.19412,60.1789194,13.719616,485433.553059013,1164531.73901911,27.0846481323242,41,1.43272319786368,-2.49135652564168 +-145.12772,60.1745244,13.719616,489137.675677538,1164531.75641007,23.9487018585205,41,1.37928197741819,-2.68547029194265 +-145.06134,60.1700966,13.719616,492841.67960717,1164531.7598977,25.2950859069824,41,1.40303615869478,-2.59918832542773 +-144.99498,60.165636,13.719616,496545.571912983,1164531.74859985,29.0958843231201,41,1.46383156141995,-2.37836206999434 +-144.92863,60.1611426,13.719616,500249.907681819,1164531.79697798,30.9999256134033,41,1.49136065171404,-2.27836855646157 +-144.86231,60.1566164,13.719616,503953.597917584,1164531.75408968,35.4662094116211,41,1.54981477404886,-2.0660464996739 +-144.796,60.1520574,13.719616,507657.745724408,1164531.77031489,34.2863006591797,41,1.53512062918101,-2.11941982796044 +-144.72971,60.1474657,13.719616,511361.808567326,1164531.78058932,31,41,1.49136169383427,-2.27836477118343 +-144.66344,60.1428412,13.719616,515065.795023109,1164531.77303876,27,41,1.43136376415899,-2.49629437687814 +-144.59719,60.1381841,13.719616,518769.708973632,1164531.76902829,21.2427845001221,41,1.32721144337824,-2.87460533398585 +-144.53096,60.1334942,13.719616,522473.560564755,1164531.74564599,14.7605619430542,41,1.16910289164163,-3.44890072256681 +-143.34213,60.0434992,12.04148726,589145.672334738,1164531.75429325,24,40,1.38021124171161,-2.68209493879053 +-143.27628,60.0381906,13.719616,592849.584765155,1164531.74299783,33,40,1.51851393987789,-2.17974006353042 +-143.21045,60.0328495,13.719616,596553.568090752,1164531.7335984,46.864444732666,40,1.67084347571057,-1.62643571020789 +-143.14464,60.0274761,13.719616,600257.625504457,1164531.74773836,62.844654083252,40,1.7982683400826,-1.16359223213138 +-143.07885,60.0220703,13.719616,603961.765599111,1164531.77396491,97.662109375,40,1.9897261002474,-0.468162999727443 +-143.01308,60.0166321,13.719616,607665.995164384,1164531.8118796,105.131637573242,40,2.02173342921435,-0.351903245118272 +-142.94734,60.0111615,13.719616,611369.772958602,1164531.76904182,105.731887817383,40,2.02420598649943,-0.342922211320728 +-142.88162,60.0056586,13.719616,615073.651923642,1164531.7470557,99.5984649658203,40,1.99825264503001,-0.437192155358827 +-142.81592,60.0001234,13.719616,618777.638800846,1164531.74556588,103.213500976562,40,2.0137365094629,-0.380950340203683 +-142.75024,59.9945559,13.719616,622481.740326325,1164531.76423309,94.8462371826172,40,1.97702010588107,-0.514314797917817 +-142.68458,59.9889561,13.719616,626185.963230928,1164531.80273416,89.7943649291992,40,1.95324908324924,-0.600657937041983 +-142.61895,59.983324,13.719616,629889.766214067,1164531.76591481,88.7554931640625,40,1.94819524146813,-0.619014932901021 +-142.55334,59.9776597,13.719616,633593.70210411,1164531.75823328,88.5665512084961,40,1.9472697335309,-0.622376641895328 +-142.48775,59.9719631,13.719616,637297.779512266,1164531.76839291,86.3444366455078,40,1.93623436029383,-0.662460267301484 +-142.42218,59.9662344,13.719616,641002.001268499,1164531.8181622,75.2348785400391,40,1.87641922417894,-0.879725914610363 +-142.35664,59.9604733,13.719616,644705.831837608,1164531.77717241,70.6418838500977,40,1.84906227231913,-0.979094172216631 +-142.29112,59.9546802,13.719616,648409.818131006,1164531.78520446,65.944580078125,40,1.81917910710164,-1.08763835779109 +-142.22562,59.9488548,13.719616,652113.972661441,1164531.80900518,60.0188484191895,40,1.77828765836658,-1.23616777117829 +-142.16015,59.9429973,13.719616,655817.750124164,1164531.77163954,51.4109230041504,40,1.71105540102733,-1.48037451983122 +-142.0947,59.9371076,13.719616,659521.707156708,1164531.75954751,50.9599571228027,40,1.70722905391642,-1.49427290468624 +-142.02927,59.9311858,13.719616,663225.848398515,1164531.78356094,40.8357772827148,40,1.61104082651889,-1.84365600144752 +-141.96387,59.9252319,13.719616,666929.632429733,1164531.74309484,30.8300533294678,40,1.4889742759647,-2.28703655432261 +-141.89849,59.9192459,13.719616,670633.613877327,1164531.73731333,25.3244514465332,40,1.40354004687244,-2.59735805974245 +-141.83313,59.9132279,13.719616,674337.797299166,1164531.77708311,28.0243759155273,40,1.44753594992141,-2.43755238218766 +-141.7678,59.9071778,13.719616,678041.643274502,1164531.7491926,17.8236751556396,40,1.25099725835681,-3.15143700767784 +-141.70249,59.9010956,13.719616,681745.70641358,1164531.75452574,13.7903499603271,40,1.13957528748915,-3.55615340886591 +-141.6372,59.8949815,13.719616,685449.989155244,1164531.81497957,19.4026947021484,40,1.2878620501881,-3.01753356148743 +-141.57194,59.8888353,13.719616,689153.954142544,1164531.80472768,35.7066040039062,40,1.55274854712648,-2.05539019847379 +-141.50671,59.8826572,13.719616,692857.603759841,1164531.74401647,35.2692070007324,40,1.54739569502111,-2.07483328517659 +-140.07787,59.7386822,12.7618702,774345.950868136,1164531.81126688,19.0733051300049,40,1.28042595656718,-3.04454357599103 +-140.01323,59.7317734,13.719616,778049.536968968,1164531.72087683,76.3909530639648,40,1.88304192837876,-0.855670362648636 +-139.9486,59.7248331,13.719616,781754.048025129,1164531.8330123,96.8702926635742,40,1.98619061182502,-0.48100490280641 +-139.88401,59.7178612,13.719616,785457.848543687,1164531.78387862,75.7206039428711,40,1.8792140692116,-0.869574239723536 +-139.81944,59.7108579,13.719616,789162.03608991,1164531.82994678,59.408519744873,40,1.77384873139297,-1.25229122094234 +-139.75491,59.7038231,13.719616,792865.523174122,1164531.72181621,102.356895446777,40,2.01011710497228,-0.394097050394514 +-139.69039,59.6967568,13.719616,796569.960082888,1164531.81629861,28.5952262878418,40,1.45629353767836,-2.40574232378999 +-139.62591,59.689659,13.719616,800273.708939568,1164531.75389406,142.260604858398,40,2.15308465088303,0.125201883353644 +-139.56145,59.6825299,13.17123165,803977.867167989,1164531.79556634,197.682159423828,40,2.29596747652965,0.64419308892085 +-146.93344,60.2486992,12.75628657,389129.834929932,1160827.78160374,294.777954101562,41,2.46949500031979,1.27449458501303 +-146.86669,60.2451653,13.719616,392833.806522346,1160827.78035681,261.664215087891,41,2.41774433306207,1.08652139042195 +-146.79995,60.2415983,13.719616,396538.023138699,1160827.80512995,208.425872802734,41,2.31895162882143,0.727678090374802 +-146.73323,60.2379982,13.719616,400241.94346138,1160827.79599469,195.759353637695,41,2.29172252238355,0.628774203831676 +-146.66653,60.234365,11.54396587,403945.574753049,1160827.75163471,19.1525421142578,41,1.28222642597684,-3.03800375719001 +-146.59983,60.2306988,11.30432026,407650.020196845,1160827.80463203,21,41,1.32221929473392,-2.8927382427631 +-146.53316,60.2269995,13.719616,411353.642517684,1160827.76011382,92.246452331543,41,1.964949672799,-0.558158056116515 +-146.4665,60.2232672,13.719616,415057.544868967,1160827.75125326,115.660064697266,41,2.06318343090081,-0.201345007984691 +-146.39985,60.2195018,13.719616,418761.735742159,1160827.76736434,120.28475189209,140,2.08021057672602,-0.139497554316228 +-146.33322,60.2157034,13.719616,422465.672509088,1160827.75638956,107.071228027344,140,2.02967278373856,-0.323065243368946 +-146.2666,60.2118721,13.719616,426169.909661002,1160827.79239609,106.48509979248,140,2.02728884222898,-0.331724399376381 +-146.2,60.2080077,13.719616,429873.908404578,1160827.78891529,103.576652526855,140,2.01526187103207,-0.375409791602917 +-146.13342,60.2041104,13.719616,433577.673328891,1160827.76698539,108.264587402344,140,2.03448642513187,-0.305580723878409 +-146.06685,60.20018,13.719616,437281.762845213,1160827.76907932,98.3944931030273,140,1.99297079272105,-0.456377350535727 +-146.0003,60.1962167,13.719616,440985.632906329,1160827.7515363,105.562690734863,140,2.02351045161632,-0.34544859254163 +-145.93376,60.1922205,13.719616,444689.839250003,1160827.78018874,110.175491333008,140,2.04208499594382,-0.277980545841356 +-145.86724,60.1881913,13.719616,448393.841808376,1160827.77698154,110.518249511719,140,2.04343399754902,-0.273080586967883 +-145.80074,60.1841293,13.719616,452097.645006067,1160827.76302401,116.135986328125,140,2.06496681269379,-0.194867256284736 +-145.73425,60.1800342,13.719616,455801.808700667,1160827.77257816,119.347770690918,140,2.07681431118798,-0.151833760141115 +-145.66778,60.1759063,13.719616,459505.787314136,1160827.77036521,113.572570800781,140,2.05527345647853,-0.230076292817873 +-145.60133,60.1717456,13.719616,463209.587946784,1160827.75534123,107.891220092773,41,2.03298610436405,-0.311030317141282 +-145.53489,60.1675519,13.719616,466913.769122138,1160827.77459994,94.4148941040039,41,1.97504051036748,-0.52150525385599 +-145.46847,60.1633254,13.719616,470617.786549317,1160827.78013324,80.9269866943359,41,1.90809336979592,-0.764676377028257 +-145.40207,60.159066,13.719616,474321.64876007,1160827.75985929,71.4071884155273,41,1.85374193351364,-0.962096307049902 +-145.33568,60.1547738,13.719616,478025.91000025,1160827.79587695,62.2415542602539,41,1.79408042906877,-1.1788039202824 +-145.26931,60.1504487,13.719616,481730.030231414,1160827.80527774,52.8612403869629,41,1.72313734961849,-1.43648943401667 +-145.20296,60.1460909,13.719616,485434.013607681,1160827.80929846,50.0545196533203,41,1.69944329803665,-1.52255299231756 +-145.13663,60.1417002,13.719616,489137.870143073,1160827.78484378,47.5452003479004,41,1.67710668178593,-1.60368595804518 +-145.07032,60.1372768,13.719616,492841.603938777,1160827.75317926,48.5330505371094,41,1.68603758968323,-1.57124635142727 +-145.00402,60.1328206,13.719616,496545.772117991,1160827.77710003,52.621524810791,41,1.72116342845736,-1.44365927908709 +-144.93774,60.1283316,13.719616,500249.833154579,1160827.78208281,58.4996871948242,41,1.76715354386124,-1.27661005305437 +-144.87148,60.1238099,13.719616,503953.792569451,1160827.77835294,63.5896987915039,41,1.80338676784416,-1.14500064155664 +-144.80524,60.1192554,13.719616,507657.658921845,1160827.7539932,67.8924789428711,41,1.831821666261,-1.04171697437865 +-144.73901,60.1146683,13.719616,511361.984731043,1160827.80733493,85.7655029296875,41,1.93331263866545,-0.673072794198109 +-144.67281,60.1100484,13.719616,515065.682934039,1160827.76197868,95.7843475341797,41,1.98129454524839,-0.498788814089244 +-144.60662,60.1053958,13.719616,518769.856157443,1160827.78276887,51.3225402832031,41,1.71030814426708,-1.48308876967277 +-144.54045,60.1007106,13.719616,522473.961227453,1160827.80300446,26.4551982879639,41,1.42251102102006,-2.52845006678318 +-143.61614,60.0316938,8.520359083,574329.828446546,1160827.78225638,15,40,1.17609125905568,-3.42351697744033 +-143.55027,60.0265201,12.18353735,578033.735153075,1160827.76935042,70,40,1.84509804001426,-0.993493395452483 +-143.48442,60.0213139,13.719616,581737.682628138,1160827.75677696,109.982696533203,40,2.04132436341946,-0.280743380275985 +-143.41859,60.0160753,13.719616,585441.675947818,1160827.75508047,67.5146789550781,40,1.82939820684761,-1.05051967069228 +-143.35278,60.0108043,13.719616,589145.721924728,1160827.76377469,94.6013870239258,40,1.97589750397496,-0.518392408463311 +-143.28699,60.0055009,13.719616,592849.827366449,1160827.78238971,96.1764297485352,40,1.98306865120224,-0.492344754884628 +-143.22122,60.0001651,13.719616,596553.999075519,1160827.81047197,99.5408706665039,40,1.99800143512213,-0.438104621446688 +-143.15548,59.9947969,13.719616,600257.695265484,1160827.75719896,106.287490844727,40,2.02648215467583,-0.334654518820961 +-143.08975,59.9893964,13.719616,603962.018067494,1160827.81339532,122.525108337402,141,2.0882250951905,-0.11038653568192 +-143.02405,59.9839635,13.719616,607665.87890812,1160827.78629159,125.085021972656,141,2.09720530918131,-0.0777678352590682 +-142.95837,59.9784983,13.719616,611369.831302496,1160827.77691368,124.989929199219,141,2.09687502205283,-0.0789675323830286 +-142.89271,59.9730009,13.719616,615073.880133056,1160827.79591104,116.987899780273,40,2.06814094439217,-0.183337903968824 +-142.82707,59.9674711,13.719616,618778.035851302,1160827.82086539,125.219512939453,40,2.09767201019723,-0.0760726439595105 +-142.76146,59.961909,13.719616,622481.754756251,1160827.76872855,120.201919555664,40,2.07991140315571,-0.14058423811626 +-142.69587,59.9563147,13.719616,626185.590265901,1160827.74280882,118.820236206055,40,2.07489041138761,-0.158821913351702 +-142.6303,59.9506881,13.719616,629889.550976102,1160827.73176705,110.494491577148,40,2.04334062791002,-0.273419732147082 +-142.56475,59.9450293,13.719616,633593.641688632,1160827.74632355,111.461639404297,40,2.04712542647367,-0.259672263474839 +-142.49922,59.9393383,13.719616,637297.869083474,1160827.78619092,99.9188232421875,40,1.99964731064997,-0.432126331749953 +-142.43372,59.9336151,13.719616,641001.691251383,1160827.75457724,86.4339065551758,40,1.93668414226092,-0.660826530816433 +-142.36824,59.9278598,13.719616,644705.661496837,1160827.75764388,80.2614364624023,40,1.90450692816274,-0.777703356712321 +-142.30278,59.9220722,13.719616,648409.790370347,1160827.77312471,76.5440139770508,40,1.8839112329391,-0.85251280036123 +-142.23735,59.9162525,13.719616,652113.532038225,1160827.72462446,71.6487884521484,40,1.85520885107677,-0.956768043760652 +-142.17193,59.9104007,13.719616,655817.990288829,1160827.80775828,66.2615127563477,40,1.82126134664155,-1.08007506945182 +-142.10655,59.9045168,13.719616,659521.525985557,1160827.72607374,55.1706733703613,40,1.74170828465101,-1.36903449730599 +-142.04118,59.8986008,13.719616,663225.79148978,1160827.77564183,51.8406867980957,40,1.71467074654015,-1.46724255300633 +-141.97584,59.8926527,13.719616,666929.696237843,1160827.7571195,41.9534683227539,40,1.62276787007937,-1.80106003200441 +-141.91052,59.8866726,13.719616,670633.793387755,1160827.7806624,37.9780769348145,40,1.57953296993909,-1.95810152978298 +-141.84523,59.8806604,13.719616,674337.542951644,1160827.73359203,33.9010200500488,40,1.53021276591525,-2.13724658818531 +-141.77995,59.8746161,13.719616,678042.048684874,1160827.81830999,17.3628463745117,40,1.23962092264999,-3.19275910609452 +-141.71471,59.8685399,13.719616,681745.667303768,1160827.75040242,18.501091003418,40,1.26719733936482,-3.09259368949326 +-141.64948,59.8624317,13.719616,685450.053139369,1160827.82507036,14.8590116500854,40,1.17198992320726,-3.4384141998796 +-141.58429,59.8562915,13.719616,689153.566978323,1160827.7325937,23.7515869140625,40,1.37569263143443,-2.698507821057 +-141.51911,59.8501194,13.719616,692857.859015751,1160827.79353297,14.2074527740479,40,1.15251622111272,-3.50914824423492 +-141.45396,59.8439153,13.719616,696561.840678649,1160827.78874852,19.723482131958,40,1.29498359099023,-2.99166609260398 +-141.38884,59.8376793,13.719616,700265.516377529,1160827.72751446,15,40,1.17609125905568,-3.42351697744033 +-141.32373,59.8314113,13.45954622,703969.991885182,1160827.80915593,13,40,1.11394335230684,-3.64925591353076 +-140.15623,59.7131541,13.71485809,770641.855561286,1160827.78774975,53.0389060974121,40,1.72459455836887,-1.43119643590649 +-140.09162,59.7062835,13.719616,774345.621833151,1160827.73902925,93.4376373291016,40,1.97052184830528,-0.537918324220452 +-140.02703,59.6993814,13.719616,778049.755577152,1160827.77210754,113.289642333984,40,2.05419020569023,-0.23401096887156 +-139.96247,59.6924477,13.719616,781753.71678654,1160827.75859426,125.427688598633,40,2.09839341909613,-0.073452280928104 +-139.89793,59.6854826,13.719616,785458.055588601,1160827.83722954,64.5036010742188,40,1.80958396088343,-1.12249066758304 +-139.83343,59.6784859,13.719616,789161.68573718,1160827.74877491,32.2920341491699,40,1.50909540308266,-2.21395087748873 +-139.76895,59.6714579,13.719616,792865.703510791,1160827.76174615,175.626663208008,40,2.2445904500955,0.457577064448722 +-139.7045,59.6643983,13.719616,796569.573634042,1160827.72372566,46.0975723266602,40,1.66367805439405,-1.65246256564435 +-139.64007,59.6573074,13.4086164,800273.843725607,1160827.78664447,152.495620727539,40,2.18325737206856,0.234797818851494 +-139.57567,59.6501851,8.117846957,803977.973741893,1160827.81885076,30.9930839538574,40,1.49126479268023,-2.27871674383324 +-147.00726,60.2192651,11.08622705,385425.932217689,1157123.79046603,247.736450195312,33,2.39398991031642,1.00023854682249 +-146.94056,60.2157678,13.719616,389130.011497583,1157123.80098726,269.236236572266,140,2.43013351128851,1.13152242196391 +-146.87388,60.2122374,13.719616,392833.777655145,1157123.77492867,220.790771484375,140,2.34398091698664,0.818591609060941 +-146.80721,60.2086739,13.719616,396537.787098647,1157123.77064311,187.788604736328,140,2.27366923515968,0.563199511713414 +-146.74055,60.2050774,13.719616,400242.045871008,1157123.79958231,252.292251586914,140,2.4019039126471,1.02898446216868 +-146.67391,60.2014479,13.719616,403946.01205652,1157123.80126992,203.049087524414,41,2.30760104216882,0.686449519872536 +-146.60729,60.1977853,13.719616,407649.694119873,1157123.76328462,212.545028686523,41,2.32745095150846,0.758550056322315 +-146.54068,60.1940897,13.719616,411353.647201213,1157123.7573956,152.803009033203,140,2.18413190655413,0.237974377720084 +-146.47408,60.1903611,13.719616,415057.878515434,1157123.78400533,133.354095458984,140,2.1250063579181,0.0232135089622943 +-146.4075,60.1865995,13.719616,418761.846132045,1157123.78047807,116.867500305176,140,2.0676937549558,-0.184962223642319 +-146.34094,60.1828049,13.719616,422465.557258426,1157123.74557878,105.902923583984,140,2.02490794952076,-0.340372481267074 +-146.27439,60.1789774,13.719616,426169.566941704,1157123.75337004,98.4629287719727,140,1.99327274968363,-0.455280556660528 +-146.20785,60.1751168,13.719616,429873.884966691,1157123.78210756,94.4173202514648,140,1.97505167014187,-0.521464718370099 +-146.14133,60.1712234,13.719616,433577.965459948,1157123.80031701,90.8031997680664,140,1.9581011526745,-0.583033835970951 +-146.07483,60.1672969,13.719616,437281.819541142,1157123.77351322,87.0262451171875,41,1.93965024561511,-0.650052796823846 +-146.00834,60.1633376,13.719616,440985.999545569,1157123.80026555,93.7774810791016,41,1.97209856314224,-0.532191245893418 +-145.94187,60.1593453,13.719616,444689.966156405,1157123.79194692,96.7191925048828,140,1.98551266200349,-0.483467410064359 +-145.87542,60.1553202,13.719616,448393.723824156,1157123.76964703,99.4622802734375,140,1.99765841165087,-0.439350580602958 +-145.80898,60.1512621,13.719616,452097.831551749,1157123.77814214,109.099136352539,140,2.0378213126524,-0.293467460532162 +-145.74256,60.1471712,13.719616,455801.744595585,1157123.77159142,115.324996948242,140,2.0619234517879,-0.205921611756617 +-145.67615,60.1430474,13.719616,459506.020596797,1157123.8070234,121.275260925293,140,2.0837722176893,-0.126560657744058 +-145.60977,60.1388907,13.719616,463209.568402694,1157123.74556872,118.349822998047,140,2.07316761274225,-0.165079609767341 +-145.54339,60.1347012,13.719616,466914.041144394,1157123.80654006,121.81517791748,140,2.08570140385627,-0.119553302941088 +-145.47704,60.1304789,13.719616,470617.79848602,1157123.77967663,107.900779724121,140,2.03302458303935,-0.310890551609705 +-145.4107,60.1262237,13.719616,474321.947238178,1157123.79406233,106.321136474609,140,2.02661961016581,-0.334155241247679 +-145.34438,60.1219358,13.719616,478025.94246612,1157123.80059347,97.7208404541016,41,1.98998719349388,-0.467214634532818 +-145.27808,60.117615,13.719616,481729.794142244,1157123.77612872,92.5070724487305,41,1.96617493715028,-0.553707546267389 +-145.21179,60.1132615,13.719616,485434.055562298,1157123.81499522,87.4481735229492,41,1.94175074306354,-0.642423190549469 +-145.14553,60.1088752,13.719616,489137.636964418,1157123.75954373,83.0732421875,41,1.9194611604672,-0.723385316619652 +-145.07928,60.1044561,13.719616,492841.643695474,1157123.75561259,81.6155548095703,41,1.91177293723649,-0.751311137830998 +-145.01305,60.1000043,13.719616,496545.532164248,1157123.74029519,82.7419204711914,41,1.91772559681525,-0.729689379182707 +-144.94683,60.0955198,13.719616,500249.85853409,1157123.78803766,89.4388046264648,41,1.95152598611928,-0.60691671763889 +-144.88064,60.0910025,13.719616,503953.533069928,1157123.73680373,110.186515808105,41,2.04212845051902,-0.277822706421075 +-144.81446,60.0864526,13.719616,507657.658017203,1157123.75911629,149.745544433594,41,2.17535390914688,0.206090185647068 +-144.7483,60.0818699,13.719616,511361.694315534,1157123.75666496,179.374908447266,41,2.25376169241475,0.490889634285404 +-144.68216,60.0772546,13.719616,515065.645873994,1157123.75079029,147.801620483398,41,2.16967919564974,0.185478006500958 +-144.61604,60.0726067,13.719616,518769.519658965,1157123.74069298,132.775268554688,41,2.1231171885073,0.016351506439632 +-144.54993,60.067926,13.719616,522473.874946019,1157123.78212206,90.4412612915039,41,1.95636661037523,-0.589334188689554 +-144.48385,60.0632128,13.719616,526177.615684127,1157123.75074112,29.6825695037842,41,1.47250149340661,-2.34687040237384 +-144.41778,60.0584669,11.58086573,529881.850292386,1157123.78156517,23.6912708282471,41,1.37458835742569,-2.70251885944794 +-143.69234,60.0041134,13.66344532,570626.0611892,1157123.81276153,74,40,1.86923171973098,-0.905832982283367 +-143.62652,59.9989772,13.719616,574329.588985318,1157123.73889652,152.420700073242,40,2.18304395202393,0.234022616333259 +-143.56071,59.9938086,13.719616,578033.695322768,1157123.75941451,173.771423339844,40,2.23997835838291,0.440824630926559 +-143.49492,59.9886076,13.719616,581737.837879954,1157123.787867,175.378723144531,40,2.24397690384518,0.455348489344017 +-143.42915,59.9833741,13.719616,585442.025244559,1157123.81270315,161.491485595703,40,2.20814962972421,0.325213603614514 +-143.36341,59.9781083,13.719616,589145.71155079,1157123.76680435,146.348037719727,40,2.16538690365257,0.169887176825131 +-143.29768,59.9728101,13.719616,592850.003648672,1157123.81551701,137.174255371094,40,2.13727261137511,0.0677680426554696 +-143.23198,59.9674795,13.719616,596553.81005497,1157123.78039958,139.957992553711,40,2.14599770468041,0.0994600719298924 +-143.1663,59.9621166,13.719616,600257.684890012,1157123.7607555,125.748039245605,40,2.09950122194703,-0.0694284247752192 +-143.10064,59.9567213,13.719616,603961.636738127,1157123.745119,135.858047485352,141,2.13308536873821,0.0525587822402129 +-143.035,59.9512938,13.719616,607665.668707902,1157123.75514155,144.576461791992,141,2.16009759208742,0.150674887500669 +-142.96938,59.945834,13.719616,611369.789362522,1157123.7793879,137.339126586914,141,2.13779428115568,0.0696628961978798 +-142.90378,59.9403418,13.719616,615074.007303611,1157123.80644627,137.498687744141,141,2.13829855337939,0.0714945568479914 +-142.83821,59.9348175,13.719616,618777.774546502,1157123.77585722,133.133544921875,141,2.12428749603783,0.0206023974295395 +-142.77266,59.9292609,13.719616,622481.650662167,1157123.75726828,140.842361450195,141,2.14873329810925,0.109396528079516 +-142.70713,59.923672,13.719616,626185.642376735,1157123.75034335,139.603988647461,40,2.14489782676018,0.0954650013871898 +-142.64162,59.9180509,13.719616,629889.754507698,1157123.76578241,133.633926391602,40,2.12591672890448,0.0265202362305839 +-142.57613,59.9123977,13.719616,633593.991823799,1157123.81429379,119.535736083984,40,2.07749776021254,-0.149351278208135 +-142.51067,59.9067122,13.719616,637297.815678687,1157123.77758272,107.115966796875,40,2.02985421196103,-0.322406244280139 +-142.44523,59.9009946,13.719616,641001.778047051,1157123.77225267,93.2531661987305,40,1.96966358621041,-0.541035777121408 +-142.37981,59.8952448,13.719616,644705.887510157,1157123.78702319,88.8666458129883,40,1.94873878844552,-0.617040615135411 +-142.31442,59.889463,13.719616,648409.597672752,1157123.74603289,82.9626388549805,40,1.91888255753154,-0.725486967631703 +-142.24904,59.8836489,13.719616,652114.019314755,1157123.81072777,76.4689559936523,40,1.8834851609449,-0.854060415457235 +-142.18369,59.8778028,13.719616,655818.054898335,1157123.81808893,60.0090789794922,40,1.77821696125712,-1.23642456325883 +-142.11837,59.8719247,13.719616,659521.711003936,1157123.76623201,54.1071548461914,40,1.73325469772697,-1.39974033790803 +-142.05307,59.8660144,13.719616,663225.547350064,1157123.7311499,63.0151786804199,40,1.79944517204349,-1.15931764254812 +-141.98779,59.8600721,13.719616,666929.566547682,1157123.73467569,59.4713821411133,40,1.7743080318116,-1.25062291072451 +-141.92253,59.8540978,13.719616,670633.77516085,1157123.77664492,54.6997261047363,40,1.73798515171735,-1.38255797880896 +-141.8573,59.8480914,13.719616,674337.632639822,1157123.74437208,53.2137069702148,40,1.72602351377593,-1.4260060620036 +-141.79209,59.8420531,13.719616,678041.690623398,1157123.76014328,37.3400955200195,40,1.57217542458693,-1.98482623455456 +-141.7269,59.8359827,13.719616,681745.959736507,1157123.80184932,23.6537456512451,40,1.373899922531,-2.70501945148432 +-141.66174,59.8298805,13.719616,685449.891214651,1157123.79915178,22.4209899902344,40,1.350654784789,-2.78945242658612 +-141.5966,59.8237462,13.719616,689154.046900516,1157123.8210835,21.1025619506836,40,1.32433518389969,-2.88505272937813 +-141.53149,59.8175801,13.719616,692857.877953708,1157123.79620891,25.6077823638916,40,1.40837197015816,-2.57980713520052 +-141.4664,59.811382,13.719616,696561.944172296,1157123.8057035,28.7982196807861,40,1.45936564030404,-2.39458357018812 +-141.40134,59.805152,13.719616,700265.700825211,1157123.75506371,34.1296310424805,40,1.53313159337442,-2.12664457373731 +-141.3363,59.7988902,13.719616,703969.701415961,1157123.75956574,30,40,1.47712125471966,-2.33009011067369 +-141.27128,59.7925965,13.719616,707673.954518228,1157123.80820782,32,40,1.50514997831991,-2.2282817863634 +-141.20629,59.786271,13.719616,711377.915319328,1157123.80484606,28,40,1.44715803134222,-2.43892509033597 +-141.14133,59.7799136,13.719616,715081.592402984,1157123.73683983,18,40,1.25527250510331,-3.13590809121766 +-141.07639,59.7735244,13.43252224,718785.539206817,1157123.72174811,13,40,1.11394335230684,-3.64925591353076 +-140.23447,59.6875795,13.38486062,766937.75109662,1157123.76453425,16.6406078338623,40,1.22116918578109,-3.25978108105238 +-140.16989,59.680747,13.719616,770641.707492693,1157123.75338901,74.0864410400391,40,1.86973873267151,-0.903991366567435 +-140.10533,59.673883,13.719616,774346.021924019,1157123.82106044,57.8651275634766,40,1.76241691486081,-1.29381484155244 +-140.04081,59.6669875,13.719616,778049.602342845,1157123.73347097,137.195907592773,40,2.13734115702391,0.0680170200167908 +-139.97631,59.6600605,13.719616,781753.553261915,1157123.72295309,144.110809326172,40,2.15869655718212,0.145585928829446 +-139.91183,59.653102,13.719616,785457.880904616,1157123.78977107,144.172912597656,40,2.15888367221138,0.146265584023653 +-139.84738,59.6461121,13.719616,789162.039981553,1157123.82630288,19.5600700378418,40,1.29137040551261,-3.00479021356449 +-139.78296,59.6390908,13.719616,792866.036672074,1157123.83116098,171.274978637695,40,2.23369392202396,0.417997764314128 +-147.08095,60.1897904,9.749374994,381721.891722936,1153419.78667626,21.3992328643799,33,1.33039820471656,-2.86303010721283 +-147.01431,60.1863296,13.719616,385425.534350732,1153419.74682692,266.065979003906,140,2.42498934627083,1.11283734632884 +-146.94767,60.1828358,13.719616,389129.952533655,1153419.79472461,238.581314086914,140,2.37763642631367,0.940838025175439 +-146.88105,60.1793089,13.719616,392834.055302938,1153419.80290958,215.664321899414,140,2.33377830419472,0.781532807285064 +-146.81445,60.175749,13.719616,396537.848714207,1153419.78113925,58.6464195251465,140,1.76824150276122,-1.27265827579526 +-146.74786,60.1721561,13.719616,400241.88969315,1153419.78833415,130.229995727539,140,2.11471102631045,-0.0141820740169089 +-146.68129,60.1685302,13.719616,403945.635763093,1153419.7640135,185.062713623047,140,2.26731892605189,0.540133376475211 +-146.61473,60.1648712,13.719616,407649.645083629,1153419.75713428,145.345321655273,140,2.16240105735173,0.159041730815092 +-146.54818,60.1611793,13.719616,411353.922398995,1153419.79030747,129.124710083008,140,2.11100935942997,-0.0276275846877073 +-146.48165,60.1574544,13.719616,415057.926451506,1153419.7903166,116.289413452148,140,2.06554018000286,-0.192784622562863 +-146.41514,60.1536965,13.719616,418761.664449126,1153419.75590419,70.0334014892578,41,1.84530522033828,-0.992740857380489 +-146.34864,60.1499057,13.719616,422465.692009763,1153419.76055405,68.4655532836914,41,1.83547212212659,-1.02845747673098 +-146.28215,60.146082,13.719616,426170.016300443,1153419.80471364,78.5341796875,41,1.89505871176421,-0.812021975461218 +-146.21569,60.1422253,13.719616,429873.546393541,1153419.74828242,79.9145660400391,41,1.90262594544993,-0.784535622811168 +-146.14923,60.1383357,13.719616,433577.937260907,1153419.79536748,81.6756973266602,41,1.91209285106089,-0.750149119508281 +-146.0828,60.1344132,13.719616,437281.546959898,1153419.75060836,82.1522979736328,41,1.91461971607674,-0.740970824531607 +-146.01637,60.1304577,13.719616,440986.033081496,1153419.79928101,81.9537353515625,41,1.91356875297181,-0.744788222503439 +-145.94997,60.1264695,13.719616,444689.749651524,1153419.77602311,86.2515335083008,41,1.93576682534847,-0.664158487670772 +-145.88358,60.1224483,13.719616,448393.807236146,1153419.7797681,91.0553436279297,140,1.95930543766555,-0.578659529146309 +-145.81721,60.1183942,13.719616,452097.661934448,1153419.75411429,96.083251953125,140,1.98264769341023,-0.493873793738523 +-145.75085,60.1143074,13.719616,455801.867810273,1153419.78880558,101.193588256836,140,2.00515299597324,-0.412128111176791 +-145.68451,60.1101877,13.719616,459505.885022733,1153419.79305593,111.613815307617,140,2.04771795392522,-0.25752003464662 +-145.61819,60.1060351,13.719616,463209.720699371,1153419.76581553,124.116004943848,140,2.09382778803068,-0.0900359561186523 +-145.55188,60.1018498,13.719616,466913.9288253,1153419.79854546,126.195930480957,140,2.10104535016833,-0.0638197103373719 +-145.48559,60.0976316,13.719616,470617.969613811,1153419.7988472,129.619140625,140,2.11266913775394,-0.0215987960671708 +-145.41932,60.0933807,13.719616,474321.847298043,1153419.78790426,128.520385742188,140,2.10897202037662,-0.0350277816439475 +-145.35307,60.0890969,13.719616,478025.571826599,1153419.74254972,126.371887207031,140,2.10165047118692,-0.06162173807913 +-145.28683,60.0847805,13.719616,481729.695616214,1153419.76762121,121.398895263672,140,2.08421473465461,-0.124953309819157 +-145.22061,60.0804312,13.719616,485433.680392878,1153419.75747957,118.10636138916,41,2.07227329000815,-0.168328045202739 +-145.15441,60.0760493,13.719616,489137.528799077,1153419.74445059,111.311500549316,41,2.04654003735429,-0.261798563843119 +-145.08822,60.0716346,13.719616,492841.800521067,1153419.77965445,104.942176818848,41,2.02095006853974,-0.354748634681838 +-145.02205,60.0671872,13.719616,496545.951408482,1153419.80017938,102.585174560547,41,2.01108460179166,-0.390582825795413 +-144.9559,60.0627071,13.719616,500249.988480148,1153419.80513984,112.161415100098,41,2.0498434799939,-0.249799517279646 +-144.88977,60.0581943,13.719616,503953.918750512,1153419.79366748,148.118240356445,140,2.17060854399295,0.188853664945926 +-144.82366,60.0536488,13.719616,507657.749229602,1153419.76491104,185.903121948242,140,2.26928668312053,0.547280831802296 +-144.75756,60.0490707,13.719616,511362.035070984,1153419.8061113,204.788619995117,140,2.31130581943933,0.699906328367751 +-144.69149,60.04446,13.719616,515065.68384396,1153419.76300515,196.803070068359,140,2.29403186901071,0.637162409934672 +-144.62543,60.0398166,13.719616,518769.803484312,1153419.77827213,199.473770141602,140,2.2998857961045,0.658425544016475 +-144.55939,60.0351406,13.719616,522473.849700319,1153419.78520033,163.69189453125,140,2.21402717515108,0.346562526223397 +-144.49337,60.030432,13.719616,526177.82944651,1153419.78301875,105.688774108887,41,2.02402886051957,-0.343565583436387 +-144.42737,60.0256908,13.69244617,529881.749672848,1153419.77097329,51.4697036743164,41,1.71155166790085,-1.47857193689795 +-143.83423,59.9815558,12.382504,563217.648812423,1153419.75129573,25,40,1.39794000867204,-2.61769899689636 +-143.76842,59.9764895,13.719616,566921.889009266,1153419.78984038,89.1880416870117,40,1.95030662817102,-0.611345773746366 +-143.70264,59.9713908,13.719616,570625.592475386,1153419.74859277,184.000793457031,40,2.26481969579903,0.531055458845517 +-143.63687,59.9662596,13.719616,574329.867174911,1153419.78723019,219.867263793945,40,2.34216057173461,0.811979595527305 +-143.57113,59.961096,13.719616,578033.618815333,1153419.74385158,231.458633422852,40,2.36447338463482,0.893026100691728 +-143.5054,59.9559001,13.719616,581737.951853013,1153419.80248953,227.989654541016,40,2.35791514051937,0.869204686155182 +-143.4397,59.9506718,13.719616,585441.775439783,1153419.77694634,214.595703125,40,2.33162102178751,0.77369694183237 +-143.37402,59.9454111,13.719616,589145.646082593,1153419.75376227,180.205581665039,40,2.25576823863408,0.498177982879311 +-143.30836,59.9401181,13.719616,592849.568791363,1153419.74349377,157.036712646484,40,2.19600119531307,0.281087022324867 +-143.24272,59.9347927,13.719616,596553.55213446,1153419.73463262,143.692352294922,141,2.1574336543938,0.140998705433935 +-143.1771,59.9294351,13.719616,600257.599275435,1153419.7487993,145.72966003418,141,2.16354795175797,0.163207578654806 +-143.1115,59.9240451,13.719616,603961.720587004,1153419.76348295,141.674026489258,141,2.1512902370764,0.118684060231252 +-143.04592,59.9186229,13.719616,607665.919178961,1153419.80032913,146.862121582031,141,2.16690979777016,0.175418762937471 +-142.98037,59.9131684,13.719616,611369.653910874,1153419.75583767,139.595321655273,141,2.14487086375029,0.0953670640392483 +-142.91483,59.9076816,13.719616,615074.030920851,1153419.81317715,144.273941040039,141,2.15918789530331,0.147370609127478 +-142.84932,59.9021626,13.719616,618777.955675403,1153419.79832435,137.275283813477,141,2.13759235027615,0.0689294256065913 +-142.78383,59.8966114,13.719616,622481.984570264,1153419.80297366,162.011413574219,141,2.20954561131852,0.330284207217889 +-142.71837,59.8910281,13.719616,626185.572706582,1153419.74350973,170.825576782227,141,2.23255289576625,0.413853231264793 +-142.65292,59.8854125,13.719616,629889.829939419,1153419.78557523,158.744155883789,141,2.20069774584344,0.298146234380158 +-142.5875,59.8797647,13.719616,633593.661670911,1153419.75074139,125.014434814453,40,2.09696016179467,-0.0786582805393487 +-142.5221,59.8740848,13.719616,637297.622352641,1153419.74401363,73.6082534790039,40,1.86692651324272,-0.914206150220167 +-142.45672,59.8683728,13.719616,641001.718622147,1153419.7651016,65.3233489990234,40,1.81506844205532,-1.10256946653995 +-142.39136,59.8626286,13.719616,644705.959056504,1153419.8027181,95.5762023925781,40,1.98034977034973,-0.502220506186783 +-142.32603,59.8568524,13.719616,648409.796704351,1153419.78099559,80.9253082275391,40,1.90808436221442,-0.76470909513525 +-142.26072,59.851044,13.719616,652113.791787118,1153419.77418796,81.0608901977539,40,1.90881136878452,-0.762068399764319 +-142.19543,59.8452036,13.719616,655817.946998754,1153419.8040871,79.6650085449219,40,1.90126760705754,-0.789469495560701 +-142.13017,59.8393311,13.719616,659521.721206273,1153419.76016137,81.7302551269531,40,1.91238285460282,-0.749095743868719 +-142.06493,59.8334266,13.719616,663225.668715389,1153419.75141091,79.8730010986328,40,1.9024000026507,-0.785356311548457 +-141.99971,59.8274901,13.719616,666929.7960935,1153419.77764899,76.420036315918,40,1.88320723973552,-0.855069904616304 +-141.93452,59.8215216,13.719616,670633.560203154,1153419.73772218,71.8511734008789,40,1.85643386498751,-0.95231844358305 +-141.86935,59.815521,13.719616,674337.519331494,1153419.72034466,63.8158531188965,40,1.80492857945489,-1.13940034170965 +-141.8042,59.8094886,13.719616,678041.673935473,1153419.75836657,65.5676727294922,40,1.81668976901536,-1.09668034424831 +-141.73907,59.8034241,13.719616,681746.036654426,1153419.81867252,54.0657997131348,40,1.73292263123155,-1.40094649820061 +-141.67397,59.7973278,13.719616,685450.05817014,1153419.83091803,52.282054901123,40,1.7183526488144,-1.4538688330267 +-141.6089,59.7911995,13.719616,689153.749101058,1153419.77134596,47.2044258117676,40,1.67398271930186,-1.61503308145497 +-141.54385,59.7850393,13.719616,692857.663589986,1153419.75351945,44.9621238708496,40,1.65284681776573,-1.69180470862111 +-141.47882,59.7788472,13.719616,696561.808127618,1153419.77736855,40.3638076782227,40,1.60599212821999,-1.86199431471109 +-141.41382,59.7726233,13.719616,700265.637392942,1153419.74837686,40.3669776916504,40,1.60602623464751,-1.8618704304314 +-141.34884,59.7663675,13.719616,703969.709649911,1153419.7598468,42.4734954833984,40,1.62811800402536,-1.78162681843231 +-141.28388,59.7600799,13.719616,707674.029244061,1153419.8227322,41.698616027832,40,1.62012164103011,-1.81067189122027 +-141.21895,59.7537605,13.719616,711378.052911805,1153419.82989993,40.1310195922852,40,1.60348019381503,-1.87111837744739 +-141.15405,59.7474093,13.719616,715081.787083211,1153419.77967607,30,40,1.47712125471966,-2.33009011067369 +-141.08917,59.7410263,13.719616,718785.787881992,1153419.77863451,30,40,1.47712125471966,-2.33009011067369 +-141.02431,59.7346115,13.719616,722490.061726711,1153419.82680446,26,40,1.41497334797082,-2.55582904676412 +-140.95948,59.728165,13.719616,726194.063149041,1153419.8258493,24,40,1.38021124171161,-2.68209493879053 +-140.89468,59.7216868,13.34251212,729897.798523844,1153419.77414834,15,40,1.17609125905568,-3.42351697744033 +-140.8299,59.7151769,13.14964554,733601.823919558,1153419.7805595,15,40,1.17609125905568,-3.42351697744033 +-140.76515,59.7086353,13.08877615,737305.596000028,1153419.73414328,13,40,1.11394335230684,-3.64925591353076 +-140.70042,59.7020621,12.54010115,741009.668597537,1153419.75586147,11,40,1.04139268515823,-3.91278064463658 +-140.63571,59.6954571,13.05793245,744714.052501843,1153419.82390549,26.2297630310059,40,1.4187943670375,-2.54195001488651 +-140.57104,59.6888206,13.719616,748417.647954347,1153419.74588216,24.0699424743652,40,1.38147505234002,-2.67750441786065 +-140.50639,59.6821525,13.719616,752121.56288598,1153419.73412522,28.3799018859863,40,1.45301088969621,-2.41766583822217 +-140.44176,59.6754527,13.719616,755825.805865623,1153419.77783322,26.1861019134521,40,1.4180708537717,-2.54457802157915 +-140.37716,59.6687214,13.719616,759529.828966122,1153419.78470377,22.3759384155273,40,1.34978125807238,-2.79262532495025 +-140.31259,59.6619585,13.719616,763233.6407338,1153419.74228898,20.5557098388672,40,1.31293247862453,-2.92647060959363 +-140.24804,59.6551641,13.719616,766937.794852858,1153419.77553453,81.3047332763672,40,1.91011582943134,-0.75733022636493 +-140.18352,59.6483382,13.719616,770641.747869871,1153419.76859895,22.3236923217773,40,1.34876602818457,-2.79631292967825 +-140.11902,59.6414808,13.719616,774346.05572417,1153419.83662198,123.939002990723,40,2.09320799820894,-0.0922872096568473 +-140.05456,59.6345919,13.719616,778049.625250915,1153419.7455186,93.7710189819336,40,1.97206863538337,-0.532299952055849 +-139.99012,59.6276715,13.719616,781753.562076731,1153419.72761383,62.7266731262207,40,1.79745225420019,-1.16655648899039 +-139.9257,59.6207197,13.719616,785457.870071306,1153419.79409639,138.745178222656,40,2.14221789912675,0.0857307392950603 +-139.86131,59.6137365,13.719616,789162.005719163,1153419.8264005,63.3297157287598,40,1.80160753859248,-1.15146331004133 +-139.79695,59.6067218,12.70204324,792865.977571385,1153419.81220382,97.7874374389648,40,1.99028306540752,-0.466139943292231 +-139.66831,59.5925984,9.372365558,800273.992423756,1153419.81394265,51.0317764282227,40,1.70784068648913,-1.49205128060485 +-147.15451,60.1602752,10.62258023,378017.722693174,1149715.77160983,170.139144897461,33,2.23080424575319,0.407501635302977 +-147.08791,60.1568509,13.719616,381722.032206105,1149715.80446641,219.374633789062,140,2.34118640882518,0.808441157786487 +-147.02133,60.1533935,13.719616,385426.009529113,1149715.79503028,299.191375732422,140,2.47594907072384,1.29793761089562 +-146.95477,60.1499032,13.719616,389129.659560871,1149715.76414212,202.269973754883,140,2.30593141811234,0.680384968741277 +-146.88822,60.1463798,13.719616,392833.542145965,1149715.74732356,109.64306640625,140,2.0399811730248,-0.285622231174064 +-146.82168,60.1428235,13.719616,396537.662131448,1149715.76711951,94.1781768798828,140,1.97395027902802,-0.525465285263913 +-146.75515,60.1392341,13.719616,400242.029142245,1149715.80161364,111.185905456543,140,2.04604973715243,-0.263579474121885 +-146.68865,60.1356118,13.719616,403945.547459447,1149715.75173161,117.649780273438,140,2.07059112041027,-0.174438165321218 +-146.62215,60.1319565,13.719616,407649.876276756,1149715.7875146,114.490028381348,140,2.05876766302926,-0.217384337279769 +-146.55567,60.1282682,13.719616,411353.922292107,1149715.78713031,116.428405761719,140,2.06605895076528,-0.190900299081842 +-146.48921,60.124547,13.719616,415057.691451829,1149715.76041126,70.3259582519531,41,1.84711565851517,-0.98616482917153 +-146.42276,60.1207929,13.719616,418761.741184446,1149715.76914766,71.2142333984375,41,1.85256680358939,-0.966364714350237 +-146.35633,60.1170059,13.719616,422465.528400493,1149715.75015082,68.0263671875,41,1.83267727894897,-1.03860914487977 +-146.28991,60.1131859,13.719616,426169.61181647,1149715.75525327,69.0978164672852,41,1.83946432362322,-1.01395666140746 +-146.2235,60.109333,13.719616,429873.997319184,1149715.7960266,70.9616012573242,41,1.85102340684303,-0.971970771862303 +-146.15712,60.1054473,13.719616,433577.590232951,1149715.75348081,75.5785903930664,41,1.87839878768391,-0.87253557493662 +-146.09074,60.1015287,13.719616,437282.049777002,1149715.8111909,78.1255493164062,41,1.89279308397447,-0.820251382268096 +-146.02439,60.0975772,13.719616,440985.732328473,1149715.77213596,81.089469909668,41,1.90896446139929,-0.7615123236905 +-145.95805,60.0935928,13.719616,444689.745546162,1149715.76742096,84.290901184082,41,1.92578069705874,-0.700430955943862 +-145.89173,60.0895756,13.719616,448393.544951495,1149715.74117687,87.9959259033203,41,1.94446256534715,-0.632573077984264 +-145.82542,60.0855256,13.719616,452097.687904964,1149715.76036805,91.7641448974609,140,1.96267302199696,-0.566427501650338 +-145.75913,60.0814428,13.719616,455801.631248813,1149715.75694046,97.2948303222656,140,1.98808976501491,-0.474106636348422 +-145.69285,60.0773272,13.719616,459505.932335502,1149715.79900883,99.8024520874023,140,1.99914121177781,-0.433964627308637 +-145.62659,60.0731787,13.719616,463210.04940554,1149715.80634357,106.790573120117,140,2.02853291727485,-0.327205563715412 +-145.56035,60.0689975,13.719616,466913.986744464,1149715.80009426,113.872665405273,140,2.05641948625328,-0.225913585566529 +-145.49413,60.0647835,13.719616,470617.752830622,1149715.76814037,125.904815673828,140,2.10004234155006,-0.0674629239260904 +-145.42792,60.0605368,13.719616,474321.903560498,1149715.79198772,131.796875,140,2.11990511294126,0.00468433116612302 +-145.36173,60.0562573,13.719616,478025.897169127,1149715.78924658,131.663009643555,140,2.11946377827124,0.00308127767518309 +-145.29556,60.0519451,13.719616,481729.739265383,1149715.77003233,129.732696533203,140,2.11304944512335,-0.0202174111509168 +-145.2294,60.0476002,13.719616,485433.987139525,1149715.80648085,129.183197021484,140,2.11120602824559,-0.0269132274145049 +-145.16327,60.0432225,13.719616,489137.548789907,1149715.74093224,125.504013061523,140,2.09865761284981,-0.0724926538063228 +-145.09715,60.0388122,13.719616,492841.528798979,1149715.74138075,114.987945556641,140,2.06065231467855,-0.210538744556408 +-145.03104,60.0343692,13.719616,496545.935659699,1149715.79750544,106.638938903809,140,2.0279158150394,-0.329447055173087 +-144.96496,60.0298935,13.719616,500249.675873764,1149715.75943614,126.288284301758,140,2.10136306315153,-0.0626656860980631 +-144.89889,60.0253852,13.719616,503953.855439156,1149715.78747262,164.447952270508,140,2.21602846995515,0.353831800178203 +-144.83284,60.0208442,13.719616,507657.932611704,1149715.79490793,200.044525146484,140,2.3011266700304,0.662932752296015 +-144.76681,60.0162706,13.719616,511361.912844291,1149715.79197803,221.218109130859,140,2.34482067585911,0.821641852976781 +-144.7008,60.0116644,13.719616,515065.803102163,1149715.77785562,226.459259033203,140,2.35499008198441,0.858580038661371 +-144.63481,60.0070256,13.719616,518769.610346094,1149715.75173037,224.899993896484,140,2.3519894436494,0.847680863761176 +-144.56883,60.0023542,13.719616,522473.891789488,1149715.79148151,175.609130859375,140,2.24454709345361,0.457419580750136 +-144.50288,59.9976502,13.719616,526177.553869838,1149715.73954486,106.494773864746,41,2.02732829568656,-0.331581093157312 +-144.43694,59.9929137,13.719616,529881.702443749,1149715.76413153,52.8040008544922,41,1.72266682941264,-1.43819849770418 +-144.10754,59.9687431,13.719616,548401.740494228,1149715.76288407,25.1077461242676,40,1.39980772865371,-2.61091490482255 +-144.04172,59.9638116,13.719616,552105.651493279,1149715.75946855,21.6103572845459,40,1.33466194714349,-2.84754297772494 +-143.97592,59.9588475,13.719616,555809.54868039,1149715.73796463,48,40,1.68124123737559,-1.58866807202389 +-143.91013,59.953851,13.719616,559513.985837286,1149715.80410549,42.6205978393555,40,1.62961953727195,-1.77617282110044 +-143.84437,59.9488221,13.719616,563217.86928896,1149715.78932922,71.8919296264648,40,1.85668014051624,-0.951423900568677 +-143.77863,59.9437607,13.719616,566921.757841403,1149715.76567415,121.897079467773,40,2.08599330048118,-0.118493051083806 +-143.71291,59.938667,13.719616,570625.654906275,1149715.75465767,184.475784301758,40,2.26593936543087,0.535122418533894 +-143.64721,59.9335409,13.719616,574329.569011823,1149715.7446569,242.350280761719,141,2.38444352718729,0.965563358488463 +-143.58152,59.9283824,13.719616,578034.057235035,1149715.82215697,250.736999511719,141,2.39921842449728,1.01923000269389 +-143.51586,59.9231915,13.719616,581738.025876612,1149715.81310072,254.710083007812,141,2.40604613737814,1.04403020470045 +-143.45022,59.9179683,13.719616,585442.030234619,1149715.81449071,231.138397216797,141,2.36387209742284,0.890842053913366 +-143.38461,59.9127128,13.719616,589145.526824242,1149715.73710499,197.406478881836,141,2.29536140211506,0.641991653656199 +-143.31901,59.9074249,13.719616,592849.624717926,1149715.74627729,158.322525024414,141,2.19954270764746,0.293950805971632 +-143.25343,59.9021048,13.719616,596553.776850045,1149715.77545538,147.637344360352,141,2.16919622468389,0.183723718099344 +-143.18787,59.8967524,13.719616,600257.991757871,1149715.81313733,148.76188659668,141,2.17249167743991,0.195693743125069 +-143.12234,59.8913677,13.719616,603961.725936532,1149715.76793503,141.939605712891,141,2.15210359448908,0.121638406509426 +-143.05683,59.8859507,13.719616,607665.536390308,1149715.72924699,161.333740234375,141,2.20772520226352,0.323671961933624 +-142.99133,59.8805016,13.719616,611369.976427785,1149715.81077829,151.354232788086,141,2.1799945709867,0.222946394026059 +-142.92586,59.8750202,13.719616,615073.955918733,1149715.80650602,148.691589355469,141,2.17228640362745,0.194948130047228 +-142.86041,59.8695066,13.719616,618778.029985009,1149715.81857613,160.679077148438,141,2.20595932872,0.317257805193087 +-142.79499,59.8639608,13.719616,622481.655063488,1149715.75288653,186.590957641602,141,2.27089059363605,0.553106692596331 +-142.72958,59.8583828,13.719616,626185.938357204,1149715.79598831,190.01383972168,141,2.27878523408895,0.581782280075967 +-142.6642,59.8527727,13.719616,629889.784135902,1149715.7705423,175.391525268555,141,2.24400860489079,0.455463636590066 +-142.59884,59.8471305,13.719616,633593.749302496,1149715.76995176,132.415878295898,141,2.12194006548756,0.012075859647567 +-142.5335,59.8414561,13.719616,637297.842418804,1149715.78288738,99.2332916259766,40,1.99665739739486,-0.442986550098703 +-142.46819,59.8357496,13.719616,641001.517963377,1149715.72355246,128.178939819336,40,2.10781667517037,-0.0392243252013813 +-142.40289,59.8300111,13.719616,644705.881137493,1149715.79516169,117.013084411621,40,2.06823442730211,-0.182998347357251 +-142.33762,59.8242404,13.719616,648409.841926566,1149715.78182361,113.427314758301,141,2.05471765085628,-0.232095137480625 +-142.27237,59.8184377,13.719616,652113.953310336,1149715.80183254,118.53929901123,141,2.0738623546859,-0.162556108728917 +-142.20715,59.812603,13.719616,655817.671613149,1149715.75619722,114.818153381348,141,2.06001055783608,-0.212869788583926 +-142.14195,59.8067362,13.719616,659521.555654379,1149715.73132402,105.798774719238,141,2.02448063806065,-0.341924598457024 +-142.07677,59.8008374,13.719616,663225.610040145,1149715.738013,101.499649047852,141,2.00646454060544,-0.407364206720527 +-142.01161,59.7949067,13.719616,666929.83932793,1149715.7870719,90.2505874633789,141,1.95545003751701,-0.592663442926538 +-141.94648,59.7889439,13.719616,670633.703825102,1149715.7553364,87.4032363891602,141,1.94152751409814,-0.643234021867696 +-141.88137,59.7829492,13.719616,674337.756316807,1149715.76451092,78.184211730957,141,1.89311906187835,-0.819067337477869 +-141.81628,59.7769226,13.719616,678042.003319502,1149715.81444235,73.6076889038086,141,1.86692318219191,-0.91421824954748 +-141.75122,59.770864,13.719616,681745.903137879,1149715.79134438,70.8727951049805,40,1.8504795609502,-0.973946175374139 +-141.68618,59.7647736,13.719616,685450.008443539,1149715.8186226,65.6367034912109,40,1.81714676111464,-1.09502041850517 +-141.62117,59.7586512,13.719616,689153.779591684,1149715.77041475,60.5056076049805,40,1.78179562653748,-1.2234258295078 +-141.55618,59.752497,13.719616,692857.769199735,1149715.77126425,51.8612327575684,40,1.7148428358704,-1.46661747543966 +-141.49121,59.7463109,13.719616,696561.985817973,1149715.81010325,48.2440910339355,40,1.68344412828072,-1.58066654348876 +-141.42627,59.740093,13.719616,700265.883567724,1149715.79240866,48.1090545654297,40,1.68222682227252,-1.58508814636428 +-141.36135,59.7338433,13.719616,703970.019151283,1149715.82245637,50.6513633728027,40,1.70459113967293,-1.50385456215431 +-141.29646,59.7275617,13.719616,707673.850877109,1149715.7826704,48.9781875610352,40,1.69000271000868,-1.55684390264722 +-141.23159,59.7212484,13.719616,711377.931194787,1149715.80043144,47.3378944396973,40,1.67520893687238,-1.61057910924152 +-141.16675,59.7149033,13.719616,715081.718390663,1149715.75707594,44.6385536193848,40,1.64971011412628,-1.70319811154394 +-141.10193,59.7085265,13.719616,718785.766986083,1149715.77014297,44.3350944519043,40,1.64674763802681,-1.71395867031209 +-141.03714,59.7021179,13.719616,722489.535277355,1149715.71988759,43.3481178283691,40,1.63697024519172,-1.7494729518349 +-140.97237,59.6956777,13.719616,726193.575573337,1149715.73595774,41.1679916381836,40,1.61455968065477,-1.83087451884506 +-140.90762,59.6892057,13.719616,729897.898595506,1149715.79646079,38.3481903076172,40,1.58374487394445,-1.94280269223844 +-140.8429,59.6827021,13.719616,733601.95608413,1149715.81292681,46.8100242614746,40,1.67033886622084,-1.62826859590448 +-140.77821,59.6761668,13.719616,737305.756580188,1149715.7727895,62.0630722045898,40,1.79283326993453,-1.18333395823264 +-140.71354,59.6695998,13.719616,741009.856696362,1149715.78604452,71.6551055908203,40,1.85524714031499,-0.956628966318603 +-140.6489,59.6630013,13.719616,744713.708059329,1149715.76257323,71.7753829956055,40,1.85597551858316,-0.953983288548732 +-140.58428,59.6563711,13.719616,748417.871693259,1149715.79159314,67.5304565429688,40,1.82949968579929,-1.05015107017481 +-140.51969,59.6497094,13.719616,752121.799170432,1149715.78189052,71.7840957641602,40,1.85602823411742,-0.953791810681809 +-140.45512,59.643016,13.719616,755826.051545833,1149715.82383626,59.7167816162109,40,1.77609639376189,-1.24412706967171 +-140.39059,59.6362912,13.719616,759529.527804659,1149715.72170151,54.991455078125,40,1.74029521129926,-1.37416718305082 +-140.32607,59.6295348,13.719616,763233.889514925,1149715.79518197,56.5247116088867,40,1.75223835523697,-1.3307862753564 +-140.26158,59.6227469,13.719616,766938.040147765,1149715.82611239,41.1287231445312,40,1.61414522689571,-1.83237993319486 +-140.19712,59.6159275,13.719616,770641.985947499,1149715.81301185,15.07741355896,40,1.17832684727568,-3.41539668292487 +-140.13269,59.6090767,13.719616,774345.730834432,1149715.76535295,105.274215698242,40,2.02232201457395,-0.3497653350932 +-140.06828,59.6021944,13.719616,778049.83359476,1149715.78789634,146.906051635742,40,2.16703968644972,0.175890555695567 +-140.0039,59.5952806,13.719616,781753.750197614,1149715.76316275,59.2243957519531,40,1.7725006384462,-1.25718787930907 +-139.93954,59.5883355,13.719616,785458.032420732,1149715.82986504,42.0703430175781,40,1.6239760530209,-1.79667156671103 +-139.87522,59.5813589,13.719616,789161.590621193,1149715.72873316,41.7601928710938,40,1.62076249580499,-1.80834412375975 +-147.16139,60.1273316,13.719616,378017.867562431,1146011.77890552,213.647537231445,140,2.32969789096104,0.766711581754458 +-147.09486,60.1239107,13.719616,381721.956682104,1146011.78830638,214.592178344727,140,2.33161388834927,0.773671031148599 +-147.02835,60.1204568,13.719616,385425.710179808,1146011.762288,286.803161621094,140,2.4575839345377,1.23123019433582 +-146.96185,60.11697,13.719616,389129.684917773,1146011.76915634,180.757919311523,140,2.25709733356244,0.503005635020568 +-146.89536,60.1134501,13.719616,392833.890477821,1146011.78695002,121.323387145996,140,2.08394452658324,-0.125934782659409 +-146.82889,60.1098973,13.719616,396537.780891289,1146011.77850012,100.209663391113,140,2.00090960331845,-0.42754132448381 +-146.76243,60.1063115,13.719616,400241.915375879,1146011.79159739,106.18871307373,140,2.02607835751476,-0.336121225365156 +-146.69599,60.1026927,13.719616,403945.750332956,1146011.76575222,114.616706848145,140,2.05924792621015,-0.215639884326014 +-146.62956,60.0990411,13.719616,407649.841312681,1146011.78325744,114.997772216797,140,2.06068942710732,-0.210403941622189 +-146.56315,60.0953565,13.719616,411353.647141973,1146011.76030874,114.215866088867,140,2.05772643732689,-0.221166366226211 +-146.49675,60.091639,13.719616,415057.724580089,1146011.76923249,93.0691070556641,140,1.96880554712809,-0.544152419977133 +-146.43037,60.0878886,13.719616,418761.529980394,1146011.74737548,63.1227073669434,41,1.80018561772526,-1.1566281324877 +-146.364,60.0841053,13.719616,422465.621322249,1146011.75709873,64.8932876586914,41,1.81219977717708,-1.11298927617619 +-146.29764,60.0802891,13.719616,426170.005766374,1146011.79884046,63.8371963500977,41,1.80507380509049,-1.13887284074961 +-146.23131,60.0764401,13.719616,429873.587534716,1146011.7547052,66.7747650146484,41,1.8246123683816,-1.06790320201511 +-146.16498,60.0725582,13.719616,433578.027508046,1146011.80657105,69.0265502929688,41,1.83901616940215,-1.01558448545436 +-146.09868,60.0686434,13.719616,437281.68039105,1146011.75906802,72.9743499755859,41,1.8631702351671,-0.927850024339321 +-146.03239,60.0646959,13.719616,440985.652281737,1146011.76436977,78.1801376342773,41,1.89309643066203,-0.819149540515113 +-145.96611,60.0607155,13.719616,444689.952954305,1146011.80079049,82.9620361328125,41,1.91887940237801,-0.72549842804988 +-145.89985,60.0567022,13.719616,448394.038731406,1146011.80135588,84.8863906860352,41,1.92883806805638,-0.68932571181988 +-145.83361,60.0526562,13.719616,452097.914003052,1146011.7871522,89.7422637939453,41,1.95299702063296,-0.601573500410138 +-145.76739,60.0485774,13.719616,455801.587215173,1146011.7459788,92.5556564331055,140,1.96640296531063,-0.552879282903299 +-145.70118,60.0444659,13.719616,459505.614881043,1146011.75704187,96.2257232666016,140,1.98329118408997,-0.491536451919172 +-145.63498,60.0403215,13.719616,463210.006865611,1146011.79875647,99.6349411010742,140,1.99841166840618,-0.4366145370668 +-145.56881,60.0361445,13.719616,466913.6644085,1146011.76442087,100.457138061523,140,2.00198080131912,-0.423650427595029 +-145.50265,60.0319346,13.719616,470617.700434299,1146011.75977638,107.477729797363,140,2.03131848445549,-0.317087588635309 +-145.43651,60.0276921,13.719616,474321.566922925,1146011.74733853,119.652359008789,140,2.07792126537654,-0.147812986572073 +-145.37038,60.0234168,13.719616,478025.824592975,1146011.77590528,123.629844665527,140,2.09212332357615,-0.0962270575200818 +-145.30427,60.0191089,13.719616,481729.926776784,1146011.79581042,127.940231323242,140,2.10700713161147,-0.0421648184740519 +-145.23818,60.0147682,13.719616,485433.88341385,1146011.78391225,127.565711975098,140,2.10573395729189,-0.0467893510029047 +-145.17211,60.0103949,13.719616,489137.698598758,1146011.76143746,122.652549743652,140,2.08867658090024,-0.108746610717309 +-145.10605,60.0059889,13.719616,492841.931628219,1146011.79057869,114.616653442383,140,2.05924772385019,-0.215640619355174 +-145.04001,60.0015503,13.719616,496546.037200478,1146011.80840926,117.798500061035,140,2.07113976057534,-0.172445347644217 +-144.97399,59.997079,13.719616,500250.023810809,1146011.80294817,137.2177734375,140,2.13741036797354,0.0682684139405981 +-144.90799,59.9925752,13.719616,503953.895415303,1146011.79547395,175.781661987305,140,2.24497356633999,0.458968652000975 +-144.84201,59.9880387,13.719616,507657.662026806,1146011.76296082,207.480026245117,140,2.31697629425749,0.720503111421947 +-144.77604,59.9834696,13.719616,511361.879911749,1146011.79263895,228.884918212891,140,2.35961717689163,0.875386968068755 +-144.71009,59.9788679,13.719616,515066.005217697,1146011.80779157,234.001373291016,140,2.36921840617493,0.910261373289388 +-144.64416,59.9742336,13.719616,518770.044902617,1146011.80760284,227.903167724609,140,2.357750361669,0.868606162338059 +-144.57825,59.9695668,13.719616,522474.004338701,1146011.80234487,161.868804931641,140,2.20916316035667,0.328895036162077 +-144.51236,59.9648675,13.719616,526177.890441949,1146011.79123079,88.400390625,41,1.94645418408442,-0.625338950265915 +-144.44649,59.9601356,12.70455682,529881.71172706,1146011.76242274,37.583610534668,41,1.57499849902056,-1.97457202242594 +-144.24898,59.945745,13.719616,540993.946225597,1146011.80279746,11.1453866958618,40,1.04709514118463,-3.89206769670567 +-144.18319,59.9408831,13.719616,544697.570925134,1146011.74124577,31.4008350372314,40,1.49694119734837,-2.25809842187138 +-144.11741,59.9359888,13.719616,548401.712870443,1146011.7631083,38.6023941040039,40,1.58661424026541,-1.93238033476202 +-144.05165,59.9310621,13.719616,552105.828097493,1146011.78624878,44.2581596374512,40,1.6459933509397,-1.71669845630744 +-143.98591,59.9261029,13.719616,555809.925132348,1146011.79895252,53.4776496887207,40,1.72817231202209,-1.41820101344547 +-143.92019,59.9211113,13.719616,559514.009158343,1146011.8116374,68.6546173095703,40,1.8366697506716,-1.02410734801828 +-143.8545,59.9160873,13.719616,563217.536197235,1146011.73887026,89.0372314453125,40,1.94957164743271,-0.614015433572313 +-143.78882,59.9110309,13.719616,566921.614710576,1146011.74910018,131.725646972656,40,2.11967034029447,0.00383156990221318 +-143.72316,59.9059421,13.719616,570625.700710494,1146011.75748468,210.044403076172,240,2.32231111365064,0.739880698166934 +-143.65752,59.900821,13.719616,574329.799284583,1146011.77449555,284.462860107422,240,2.45402557230116,1.21830520703502 +-143.5919,59.8956676,13.719616,578033.917217372,1146011.79956797,279.941162109375,240,2.44706676114082,1.1930288186582 +-143.5263,59.8904818,13.719616,581738.063044907,1146011.82110907,265.840515136719,240,2.42462116983256,1.11150002441703 +-143.46073,59.8852637,13.719616,585441.690992495,1146011.76148015,255.593826293945,141,2.4075503595065,1.04949396881839 +-143.39517,59.8800133,13.719616,589145.909459652,1146011.79591602,235.40315246582,141,2.37181227451992,0.919683043482119 +-143.32964,59.8747306,13.719616,592849.623581493,1146011.74705064,191.885269165039,141,2.283041635674,0.597242745530842 +-143.26412,59.8694157,13.719616,596553.939947615,1146011.80341939,158.473587036133,141,2.19995688825505,0.295455228157299 +-143.19863,59.8640685,13.719616,600257.765461316,1146011.77441679,151.593841552734,141,2.18068155859161,0.225441729092865 +-143.13316,59.858689,13.719616,603961.657687244,1146011.74886124,145.582992553711,141,2.16311064234309,0.161619146039451 +-143.06771,59.8532774,13.719616,607665.619704917,1146011.74838117,173.648284912109,141,2.23967049823195,0.439706394986231 +-143.00228,59.8478335,13.719616,611369.661875662,1146011.75048647,169.829879760742,141,2.23001410212463,0.404631608114594 +-142.93687,59.8423575,13.719616,615073.787225339,1146011.7768303,169.55322265625,141,2.22930604872057,0.402059756052469 +-142.87148,59.8368493,13.719616,618778.004283326,1146011.81598813,187.981384277344,141,2.2741148433811,0.56481808796283 +-142.80612,59.8313089,13.719616,622481.768926389,1146011.77385151,181.254653930664,141,2.25828916641797,0.507334712134848 +-142.74078,59.8257364,13.719616,626185.63676896,1146011.75369835,191.09489440918,141,2.2812490839177,0.590731685906751 +-142.67546,59.8201317,13.719616,629889.616357451,1146011.74415732,178.639007568359,141,2.25197629734069,0.484404569773911 +-142.61016,59.814495,13.719616,633593.710550793,1146011.76693685,151.443557739258,141,2.18025080359955,0.223877104011989 +-142.54488,59.8088261,13.719616,637297.929793465,1146011.7996784,152.729995727539,141,2.18392433960807,0.237220435326498 +-142.47963,59.8031252,13.719616,641001.726075709,1146011.76759398,152.872406005859,141,2.1843291008414,0.238690643656322 +-142.4144,59.7973922,13.719616,644705.658748612,1146011.75478202,142.148468017578,141,2.15274218351223,0.123957944112974 +-142.34919,59.7916271,13.719616,648409.734434557,1146011.76097058,138.132736206055,141,2.14029661463111,0.0787520856176952 +-142.284,59.7858301,13.719616,652113.955825365,1146011.8079217,139.409545898438,141,2.14429251256454,0.0932663274547677 +-142.21884,59.780001,13.719616,655817.782599845,1146011.77461721,135.749526977539,141,2.13273832495405,0.0512982201599812 +-142.1537,59.7741399,13.719616,659521.770194947,1146011.76947305,126.863739013672,141,2.10333750706993,-0.055493942224065 +-142.08858,59.7682469,13.719616,663225.923184183,1146011.80327701,122.349464416504,141,2.08760207257243,-0.112649531659112 +-142.02349,59.7623219,13.719616,666929.699289183,1146011.76439725,111.616188049316,141,2.04772718627402,-0.257486500120599 +-141.95842,59.7563649,13.719616,670633.655882445,1146011.75195819,109.938018798828,141,2.04114790624724,-0.281384323091375 +-141.89337,59.750376,13.719616,674337.797488819,1146011.77678793,92.0255737304688,141,1.96390853372207,-0.561939770414583 +-141.82835,59.7443552,13.719616,678041.57980781,1146011.73662888,89.9669799804688,141,1.95408314228834,-0.597628396547831 +-141.76335,59.7383025,13.719616,681745.560163149,1146011.7323187,83.225341796875,141,1.92025558742969,-0.720499731139866 +-141.69837,59.7322179,13.719616,685449.745058179,1146011.76372808,75.3708190917969,40,1.87720323498938,-0.876878163567872 +-141.63342,59.7261015,13.719616,689153.588105512,1146011.73796125,71.6728134155273,40,1.85535445242346,-0.956239178110698 +-141.56849,59.7199532,13.719616,692857.648661069,1146011.74658147,62.2789688110352,40,1.79434141309029,-1.177855951824 +-141.50358,59.7137731,13.719616,696561.931119691,1146011.80049012,59.9998970031738,40,1.77815050486712,-1.23666595183586 +-141.4387,59.7075612,13.719616,700265.891115341,1146011.79416824,57.205265045166,40,1.75743600212927,-1.31190693828743 +-141.37385,59.7013175,13.719616,703969.535091215,1146011.72588292,55.3998756408691,40,1.74350878984495,-1.36249454852625 +-141.30901,59.695042,13.719616,707673.971114597,1146011.80703547,56.0892753601074,40,1.74887982922079,-1.34298540046592 +-141.24421,59.6887348,13.719616,711377.551038123,1146011.72889404,55.5300941467285,40,1.74452840978393,-1.35879099787936 +-141.17942,59.6823958,13.719616,715081.935845818,1146011.80014182,55.8614463806152,40,1.74711217638804,-1.34940602009283 +-141.11466,59.6760251,13.719616,718786.028172379,1146011.81695902,57.9545631408691,40,1.76308763648391,-1.29137858917436 +-141.04993,59.6696228,13.719616,722489.832233724,1146011.78865144,58.4168281555176,40,1.76653797249455,-1.27884598395974 +-140.98522,59.6631887,13.719616,726193.909544431,1146011.80097483,59.5159072875977,40,1.7746330585673,-1.24944232077592 +-140.92054,59.6567229,13.719616,729897.713504743,1146011.75503389,62.3186111450195,40,1.79461776592934,-1.1768521594336 +-140.85588,59.6502256,13.719616,733601.796897334,1146011.78160008,93.1244506835938,40,1.96906372397608,-0.543214647974238 +-140.79125,59.6436965,13.719616,737305.621831217,1146011.73682134,121.583518981934,40,2.08487470898031,-0.122556094692772 +-140.72664,59.6371359,13.719616,741009.738846684,1146011.76357139,136.095108032227,40,2.13384251467583,0.0553089523966145 +-140.66206,59.6305437,13.719616,744713.605643561,1146011.73883976,136.844680786133,40,2.13622792085372,0.063973428497424 +-140.5975,59.6239199,13.719616,748417.779346781,1146011.77375304,142.546722412109,141,2.15395723599343,0.128371361535192 +-140.53297,59.6172645,13.719616,752121.715445662,1146011.75517834,137.893020629883,141,2.13954228518501,0.0760121457624267 +-140.46846,59.6105777,13.719616,755825.966528024,1146011.81728827,131.591659545898,141,2.11922836398933,0.00222618580933888 +-140.40398,59.6038592,13.719616,759529.994827459,1146011.81300453,132.669708251953,141,2.122771774102,0.0150968627284823 +-140.33953,59.5971093,13.719616,763233.799810542,1146011.77366239,116.033363342285,141,2.06458288088339,-0.196261806205162 +-140.2751,59.5903279,13.719616,766937.940803405,1146011.80229202,73.4051284790039,141,1.86572640313576,-0.91856529267414 +-140.2107,59.5835151,13.719616,770641.870928716,1146011.79397893,65.5445785522461,40,1.81653677532106,-1.09723606101475 +-140.14633,59.5766708,13.719616,774345.598707051,1146011.7363029,26.4605617523193,40,1.42259905993246,-2.52813028432452 +-140.08198,59.5697951,13.719616,778049.678857624,1146011.75589806,22.8662376403809,40,1.35919471264176,-2.75843297108681 +-140.01766,59.5628879,13.719616,781753.569095323,1146011.72433597,22.0493087768555,40,1.34339497933208,-2.81582211216046 +-139.95336,59.5559494,13.719616,785457.821758637,1146011.7803227,53.509822845459,40,1.72843351316138,-1.41725225635333 +-139.88909,59.5489795,13.56351964,789161.894539799,1146011.79434028,14.4456586837769,40,1.15973734930986,-3.48291904550773 +-147.23474,60.097772,12.79347446,374313.597140729,1142307.75177928,194.722915649414,33,2.2894170637669,0.620400120092621 +-147.16826,60.0943875,13.719616,378017.803303448,1142307.77589018,212.777221679688,140,2.32792513382833,0.760272421853193 +-147.1018,60.09097,13.719616,381721.66435577,1142307.76175872,249.68669128418,140,2.39739539435023,1.01260823685521 +-147.03535,60.0875195,13.719616,385425.738900872,1142307.76598993,227.169128417969,140,2.35634931177185,0.863517149212171 +-146.96891,60.0840361,13.719616,389130.032984037,1142307.7999647,139.680709838867,140,2.14513643339414,0.0963316887868395 +-146.90249,60.0805197,13.719616,392834.003615884,1142307.7936853,110.332160949707,140,2.0427021242907,-0.275738959539534 +-146.83609,60.0769704,13.719616,396537.656812448,1142307.75689272,109.905426025391,140,2.04101913404965,-0.281852060468255 +-146.7697,60.0733882,13.719616,400241.551129537,1142307.74849077,115.87028503418,140,2.06397207530531,-0.198480426406018 +-146.70332,60.0697731,13.719616,403945.693746797,1142307.76880687,119.535743713379,140,2.07749778793148,-0.149351177525034 +-146.63696,60.066125,13.719616,407649.541705068,1142307.7456884,116.112632751465,140,2.06487947241551,-0.195184501104849 +-146.57061,60.0624441,13.719616,411353.651085665,1142307.76199681,120.582946777344,140,2.08128589284416,-0.135591699249365 +-146.50427,60.0587303,13.719616,415058.030283623,1142307.80699651,64.918701171875,41,1.81236982231362,-1.11237162370457 +-146.43796,60.0549836,13.719616,418761.583718803,1142307.75497366,63.4801139831543,41,1.80263769789079,-1.14772147743315 +-146.37165,60.051204,13.719616,422465.972670322,1142307.79383909,60.689868927002,41,1.7831161995379,-1.2186291314412 +-146.30537,60.0473916,13.719616,426169.548885068,1142307.74429371,60.3062744140625,41,1.78036249956378,-1.22863135573144 +-146.23909,60.0435464,13.719616,429873.973601366,1142307.7976261,60.8863487243652,41,1.78451993075667,-1.21353037898985 +-146.17284,60.0396683,13.719616,433577.601133181,1142307.74900733,64.7024002075195,41,1.8109203916045,-1.11763636974878 +-146.1066,60.0357575,13.719616,437281.538719599,1142307.74947605,68.1797332763672,41,1.83365529790741,-1.0350567008683 +-146.04037,60.0318138,13.719616,440985.7961108,1142307.77732143,74.0310745239258,41,1.86941405299459,-0.905170695826833 +-145.97416,60.0278373,13.719616,444689.827724266,1142307.77720659,77.2245941162109,41,1.88775563437649,-0.838548837039227 +-145.90797,60.0238281,13.719616,448393.639301884,1142307.75909371,83.6653518676758,41,1.92254564188767,-0.712181599701856 +-145.84179,60.0197861,13.719616,452097.790650693,1142307.77883406,90.2071838378906,41,1.95524112486923,-0.593422273292886 +-145.77563,60.0157113,13.719616,455801.737491364,1142307.76836381,92.4392776489258,41,1.96585654309968,-0.554864044337878 +-145.70948,60.0116038,13.719616,459506.036893258,1142307.80688433,93.2749710083008,140,1.9697651227256,-0.54066696751683 +-145.64336,60.0074636,13.719616,463209.593163242,1142307.75549791,94.6183624267578,140,1.9759754273822,-0.518109368406635 +-145.57725,60.0032906,13.719616,466913.517509086,1142307.74099511,93.6447830200195,140,1.97148358770455,-0.534425012214563 +-145.51115,59.9990849,13.719616,470617.815582209,1142307.77510708,94.4966659545898,140,1.97541648593712,-0.52013960327294 +-145.44507,59.9948466,13.719616,474321.941613146,1142307.79815441,94.3161926269531,140,1.97458626076304,-0.523155218075072 +-145.37901,59.9905755,13.719616,478025.905499802,1142307.78694993,111.495811462402,140,2.04725855264935,-0.259188711206774 +-145.31297,59.9862718,13.719616,481729.711389316,1142307.76268685,117.837966918945,140,2.07128524093318,-0.171916921460298 +-145.24694,59.9819355,13.719616,485433.917648467,1142307.79748634,127.65746307373,140,2.10604620948101,-0.0456551619263797 +-145.18093,59.9775664,13.719616,489137.982856108,1142307.79624157,130.383514404297,140,2.11522268299212,-0.0123235909077113 +-145.11494,59.9731648,13.719616,492841.909588774,1142307.79127177,136.014663696289,140,2.13358573203996,0.0543762445700568 +-145.04897,59.9687305,13.719616,496545.707800381,1142307.75948565,138.749526977539,140,2.14223151120808,0.0857801822597519 +-144.98301,59.9642637,13.719616,500249.932846138,1142307.7974689,149.839385986328,140,2.17562598471358,0.207078441763404 +-144.91707,59.9597642,13.719616,503954.043342752,1142307.80795939,189.797943115234,140,2.27829150156575,0.579988902626433 +-144.85115,59.9552322,13.719616,507658.043220117,1142307.81224443,217.105209350586,140,2.33667024429768,0.792037159180893 +-144.78525,59.9506676,13.719616,511361.940956018,1142307.79838854,226.797897338867,140,2.35563902386126,0.860937180784531 +-144.71937,59.9460704,13.719616,515065.743510058,1142307.76555352,231.003524780273,140,2.36361860664948,0.889921303071031 +-144.6535,59.9414407,13.719616,518770.007641259,1142307.80210581,201.748245239258,140,2.30480976601507,0.67631080817258 +-144.58766,59.9367785,13.719616,522473.637522155,1142307.75156404,127.873931884766,140,2.10678201912694,-0.0429824912713506 +-144.52183,59.9320838,13.719616,526177.742811176,1142307.76992352,64.5449142456055,41,1.80986202813483,-1.12148064795766 +-144.45602,59.9273566,9.531631128,529881.77904444,1142307.77829368,11.8793325424194,41,1.0747920398634,-3.79146465522244 +-144.25871,59.91298,13.719616,540993.542428431,1142307.73596292,43.1476783752441,40,1.63495743282189,-1.75678406087595 +-144.19297,59.9081229,13.719616,544697.921161553,1142307.79003447,47.4102821350098,40,1.67587253978032,-1.60816871406875 +-144.12726,59.9032334,13.719616,548401.712262792,1142307.76008419,55.255500793457,40,1.74237551937665,-1.3666109103347 +-144.06156,59.8983115,13.719616,552106.025325524,1142307.81002748,61.3585662841797,40,1.78787520325279,-1.20134307159383 +-143.99589,59.8933572,13.719616,555809.764448031,1142307.77348869,71.3355484008789,40,1.85330600428387,-0.963679726439004 +-143.93023,59.8883705,13.719616,559514.03921426,1142307.81664722,82.5988464355469,40,1.91697398206403,-0.732419458491371 +-143.8646,59.8833514,13.719616,563217.753713013,1142307.77092941,104.319602966309,40,2.01836592549416,-0.364134979811254 +-143.79898,59.8783,13.719616,566922.015807668,1142307.81582994,137.433212280273,141,2.13809169754932,0.0707431974306714 +-143.73339,59.8732162,13.719616,570625.731266624,1142307.76952222,205.095642089844,240,2.31195643249689,0.702269540696246 +-143.66781,59.8681001,13.719616,574330.007921799,1142307.81376118,270.266693115234,240,2.4317925278018,1.13754844347065 +-143.60226,59.8629516,13.719616,578033.751553731,1142307.76452541,304.843811035156,240,2.48407738236412,1.32746195882427 +-143.53673,59.8577709,13.719616,581737.516835537,1142307.72927796,283.193939208984,240,2.45208395453941,1.21125269713146 +-143.47121,59.8525579,13.719616,585441.863644878,1142307.78458681,278.118774414062,240,2.4442303069124,1.18272600729596 +-143.40572,59.8473127,13.719616,589145.694227421,1142307.76522013,275.333099365234,240,2.43985842355315,1.16684607907541 +-143.34025,59.8420351,13.719616,592849.570260047,1142307.73618484,235.164764404297,141,2.3713722503499,0.918084750101227 +-143.27479,59.8367254,13.719616,596554.04451082,1142307.8199363,188.379302978516,141,2.27503318563314,0.568153769143234 +-143.20936,59.8313834,13.719616,600258.024539731,1142307.81482174,162.273544311523,141,2.21024772194546,0.332834473417247 +-143.14396,59.8260092,13.719616,603961.515274191,1142307.72974422,169.158233642578,141,2.22829314157721,0.398380588195324 +-143.07857,59.8206028,13.719616,607665.626169056,1142307.74558507,169.515014648438,141,2.22920817150765,0.401704238078224 +-143.0132,59.8151643,13.719616,611369.810714702,1142307.78255838,174.538986206055,141,2.24189244907774,0.447777154666032 +-142.94786,59.8096936,13.719616,615073.526057954,1142307.73659924,189.309417724609,141,2.27717221969064,0.57592335138119 +-142.88253,59.8041907,13.719616,618777.8816384,1142307.79198322,188.491317749023,141,2.27529135061327,0.569091498038686 +-142.81723,59.7986557,13.719616,622481.779525925,1142307.77356184,194.553466796875,240,2.28903897401069,0.619026790180473 +-142.75195,59.7930886,13.719616,626185.777744687,1142307.77357845,194.58154296875,240,2.28910164288515,0.619254421420025 +-142.68669,59.7874894,13.719616,629889.88294107,1142307.79167607,190.577133178711,240,2.28007078963875,0.586451784766954 +-142.62146,59.7818581,13.719616,633593.550383654,1142307.7321086,192.005355834961,240,2.28331334316776,0.598229664701218 +-142.55624,59.7761948,13.719616,637297.887536136,1142307.79581964,167.147399902344,141,2.22309962521906,0.379516254405367 +-142.49105,59.7704994,13.719616,641001.800179836,1142307.78011104,163.916748046875,141,2.21462332948717,0.348727928931456 +-142.42588,59.7647719,13.719616,644705.846312772,1142307.78009354,167.038391113281,141,2.22281629828823,0.378487130123032 +-142.36073,59.7590125,13.719616,648410.02865532,1142307.8175114,157.197341918945,141,2.19644519819388,0.282699767519013 +-142.29561,59.7532211,13.719616,652113.804345541,1142307.78288715,158.440170288086,141,2.19986530050287,0.295122555299644 +-142.23051,59.7473976,13.719616,655817.733304548,1142307.76203828,150.487655639648,141,2.17750087662448,0.213888584331236 +-142.16543,59.7415422,13.719616,659521.818171933,1142307.77674406,143.421997070312,141,2.1566157655132,0.138027899570852 +-142.10037,59.7356549,13.719616,663226.06548166,1142307.82677644,135.673522949219,141,2.13249510219922,0.050414765691729 +-142.03534,59.7297356,13.719616,666929.9323935,1142307.80049672,136.495239257812,141,2.13511750412316,0.0599400779875343 +-141.97033,59.7237844,13.719616,670633.974820974,1142307.80802221,119.939292907715,141,2.07896148416173,-0.144034615036246 +-141.90535,59.7178013,13.719616,674337.647909209,1142307.74763101,116.64013671875,141,2.0668480200288,-0.18803417429394 +-141.84038,59.7117863,13.719616,678042.060915667,1142307.82167877,98.8945693969727,141,1.99517244381475,-0.448380325349634 +-141.77545,59.7057395,13.719616,681745.564182529,1142307.73471449,102.178276062012,141,2.00935857105058,-0.39685226210526 +-141.71053,59.6996608,13.719616,685449.820354158,1142307.78189769,92.4275436401367,141,1.96580141135415,-0.555064298573826 +-141.64564,59.6935503,13.719616,689153.731112819,1142307.76822829,77.905143737793,141,1.89156613319491,-0.824708017706073 +-141.58077,59.6874079,13.719616,692857.856368077,1142307.78526249,63.0312461853027,40,1.79955589360904,-1.15891547021898 +-141.51593,59.6812338,13.719616,696561.647052484,1142307.74999399,72.4338531494141,40,1.85994158829362,-0.939577391331353 +-141.45111,59.6750279,13.719616,700265.663053732,1142307.75512259,73.71826171875,40,1.86757508597656,-0.911850348929751 +-141.38631,59.6687902,13.719616,703969.910813037,1142307.80058165,69.2012786865234,40,1.84011411933206,-1.01159641792283 +-141.32154,59.6625208,13.719616,707673.843271528,1142307.79073901,67.6577758789062,40,1.830317717079,-1.0471797470775 +-141.25679,59.6562196,13.719616,711378.020332169,1142307.82001886,70.3504104614258,40,1.84726663568139,-0.985616437010643 +-141.19207,59.6498867,13.719616,715081.894903362,1142307.79169925,73.6856689453125,40,1.86738303055686,-0.912547949032173 +-141.12737,59.6435222,13.719616,718786.022590237,1142307.82329944,74.9461822509766,40,1.87474951484189,-0.885790775504996 +-141.0627,59.6371259,13.719616,722489.862698136,1142307.78408277,72.9450225830078,40,1.86299566307686,-0.928484119998896 +-140.99805,59.6306981,13.719616,726193.966480878,1142307.81465277,92.3125991821289,141,1.96526097926919,-0.557027302161048 +-140.93343,59.6242385,13.719616,729897.795428974,1142307.77222257,107.86661529541,141,2.03288705138876,-0.311390105820098 +-140.86883,59.6177474,13.719616,733601.900720704,1142307.79852778,153.400375366211,141,2.1858264223201,0.244129342645041 +-140.80426,59.6112246,13.719616,737305.741691763,1142307.76067039,189.040863037109,141,2.27655569133379,0.573683944414363 +-140.73971,59.6046703,13.719616,741009.871630826,1142307.79055146,205.529067993164,141,2.31287325286064,0.705599693943987 +-140.67519,59.5980844,13.719616,744713.747676039,1142307.76515304,207.087478637695,240,2.31615384045332,0.717515724453509 +-140.61069,59.591467,13.719616,748417.925269094,1142307.80655004,203.225799560547,141,2.30797884089307,0.687821792673509 +-140.54622,59.584818,13.719616,752121.861557742,1142307.79064242,196.246322631836,141,2.29280152745212,0.632693458219434 +-140.48178,59.5781375,13.719616,755825.560578077,1142307.72683488,191.489593505859,141,2.28214517723005,0.593986552587701 +-140.41736,59.5714255,13.719616,759529.579961457,1142307.72795683,187.448211669922,141,2.27288130143621,0.560337511531064 +-140.35296,59.5646821,13.719616,763233.923679083,1142307.80510385,174.348022460938,141,2.2414170257632,0.4460502814883 +-140.28859,59.5579072,13.719616,766938.048865728,1142307.83200475,147.084289550781,141,2.1675662871002,0.177803319564894 +-140.22425,59.5511008,13.719616,770641.96176238,1142307.80716393,122.53833770752,141,2.08827198461885,-0.110216219894599 +-140.15994,59.5442631,13.719616,774345.663977136,1142307.75097975,110.246437072754,141,2.04236456290499,-0.276965078842017 +-140.09565,59.5373939,13.719616,778049.717696152,1142307.75725305,92.1554107666016,40,1.96452083925224,-0.559715701959616 +-140.03139,59.5304934,13.719616,781753.573100611,1142307.73036029,70.4841766357422,40,1.84809163087664,-0.982619818984399 +-139.96715,59.5235615,13.719616,785457.790061816,1142307.7761881,55.6991691589355,40,1.74584871703404,-1.35399526509376 +-139.90294,59.5165983,13.719616,789161.821030631,1142307.787079,42.1575965881348,40,1.62487584370678,-1.79340327011407 +-139.83876,59.5096037,13.41902195,792865.674514831,1142307.75068019,17,40,1.23044892137827,-3.22607443266317 +-147.30795,60.0681722,9.183631818,370609.782313728,1138603.78024326,25.5736103057861,33,1.40779204305178,-2.58191359597857 +-147.24153,60.0648239,13.719616,374313.55991243,1138603.74798929,185.570434570312,140,2.2685087847828,0.544455283005374 +-147.17512,60.0614428,13.719616,378017.532596858,1138603.75274973,206.556503295898,140,2.3150388730045,0.713465844436017 +-147.10872,60.0580287,13.719616,381721.709847793,1138603.7724905,270.144378662109,140,2.43159593489048,1.13683436190352 +-147.04234,60.0545816,13.719616,385425.546962186,1138603.74941292,167.078353881836,140,2.22292018778319,0.378864486421741 +-146.97597,60.0511016,13.719616,389129.601913562,1138603.75181457,114.248275756836,140,2.05784965438791,-0.220718806690929 +-146.90961,60.0475887,13.719616,392833.881888932,1138603.77996525,107.409309387207,140,2.03104192419669,-0.318092134433418 +-146.84327,60.044043,13.719616,396537.840938609,1138603.78556171,125.930213928223,140,2.10012994113292,-0.0671447372377456 +-146.77694,60.0404643,13.719616,400242.04056753,1138603.80526476,124.09644317627,140,2.0937593340285,-0.090284600593307 +-146.71063,60.0368527,13.719616,403945.934830026,1138603.78969232,118.481140136719,140,2.07364922472233,-0.163330257589968 +-146.64434,60.0332083,13.719616,407649.529662763,1138603.74862702,124.691925048828,140,2.09583832981948,-0.0827330944759827 +-146.57805,60.029531,13.719616,411353.937309585,1138603.79351769,78.8228073120117,140,1.89665189841089,-0.806235066819745 +-146.51178,60.0258208,13.719616,415058.061075369,1138603.80141712,68.8652038574219,41,1.83799983743881,-1.01927609323522 +-146.44553,60.0220779,13.719616,418761.905583134,1138603.79326834,61.2971038818359,41,1.78743995579329,-1.20292401459873 +-146.37929,60.018302,13.719616,422466.033696373,1138603.79808577,63.1651916503906,41,1.8004778181769,-1.15556677704503 +-146.31307,60.0144934,13.719616,426169.896797655,1138603.78545673,62.1050605773926,41,1.7931269897304,-1.18226708409805 +-146.24686,60.010652,13.719616,429874.055204142,1138603.80776868,62.4743614196777,41,1.7957018256896,-1.17291454496288 +-146.18067,60.0067778,13.719616,433577.964099105,1138603.80019477,64.316764831543,41,1.80832419103976,-1.12706651122935 +-146.1145,60.0028708,13.719616,437281.630592327,1138603.76153942,70.0427627563477,41,1.8453632679964,-0.992530011717728 +-146.04834,59.998931,13.719616,440985.613720075,1138603.75702699,76.9325408935547,41,1.88611007635854,-0.844525973449433 +-145.98219,59.9949584,13.719616,444689.920584385,1138603.78717004,76.2455520629883,41,1.88221451331923,-0.858675770312618 +-145.91606,59.9909532,13.719616,448394.003637135,1138603.80718197,81.4114379882812,41,1.91068542585019,-0.755261289592685 +-145.84995,59.9869151,13.719616,452097.874013212,1138603.78263074,87.4616317749023,41,1.94181757573265,-0.642180435219316 +-145.78386,59.9828444,13.719616,455801.534695815,1138603.74570583,89.5371856689453,41,1.95200343952636,-0.605182470585585 +-145.71778,59.9787409,13.719616,459505.547417402,1138603.7423058,90.4641494750977,41,1.95647650440047,-0.588935022222997 +-145.65171,59.9746048,13.719616,463209.916455895,1138603.79522028,87.4643630981445,41,1.94183113802353,-0.642131173107776 +-145.58567,59.9704359,13.719616,466913.547788825,1138603.74225676,82.9241104125977,41,1.91868082122291,-0.726219731485927 +-145.51964,59.9662344,13.719616,470617.549502512,1138603.74461607,82.544319152832,41,1.91668718970696,-0.733461170190949 +-145.45362,59.9620002,13.719616,474321.930035897,1138603.79184987,86.0732574462891,41,1.93486823917083,-0.667422409150006 +-145.38763,59.9577334,13.719616,478025.591114745,1138603.75175195,93.3100509643555,140,1.96992842663241,-0.540073801115748 +-145.32165,59.9534339,13.719616,481729.645052427,1138603.75563989,112.308479309082,140,2.05041254680577,-0.247732504191109 +-145.25569,59.9491018,13.719616,485433.545474662,1138603.74220314,121.583686828613,140,2.08487530852569,-0.122553916972843 +-145.18974,59.9447371,13.719616,489137.851298839,1138603.78413253,139,140,2.14301480025409,0.0886253116478125 +-145.12381,59.9403398,13.719616,492842.017577432,1138603.80794528,146.319839477539,140,2.16530321601909,0.169583199453498 +-145.0579,59.9359099,13.719616,496546.051288984,1138603.81271318,157.062057495117,140,2.19607128236196,0.281341598491275 +-144.99201,59.9314474,13.719616,500249.959407745,1138603.79752498,181.696014404297,140,2.25934540093927,0.51117125739553 +-144.92614,59.9269524,13.719616,503953.747380386,1138603.77256545,205.50244140625,140,2.31281698573989,0.705395315701203 +-144.86028,59.9224248,13.719616,507657.975604064,1138603.80231696,216.513793945312,140,2.33548557017437,0.787734084625382 +-144.79445,59.9178647,13.719616,511361.545634081,1138603.74466923,217.657485961914,140,2.33777360857608,0.796044893171582 +-144.72863,59.913272,13.719616,515065.569811117,1138603.74114089,198.004791259766,140,2.29667569931457,0.646765556222598 +-144.66282,59.9086469,13.719616,518770.051953198,1138603.81472412,147.567718505859,140,2.16899136285211,0.182979601452938 +-144.59704,59.9039892,13.719616,522473.898237915,1138603.78678485,73.9602890014648,41,1.86899859950574,-0.90667974148055 +-144.53128,59.8992991,13.37017333,526177.664360809,1138603.75622655,37.1850395202637,41,1.57036824739197,-1.99139041794639 +-144.39981,59.8898215,12.09693958,533585.538761214,1138603.7423389,12,40,1.07918124604762,-3.77552180555717 +-144.3341,59.885034,13.719616,537289.660815086,1138603.75860956,47.3769836425781,40,1.67556740697593,-1.60927704350787 +-144.26841,59.8802141,13.719616,540993.730215987,1138603.77033935,52.5663299560547,40,1.72070765676975,-1.44531477194668 +-144.20274,59.8753617,13.719616,544697.755462525,1138603.76574723,59.0098724365234,40,1.77092467581213,-1.26291222542054 +-144.13709,59.870477,13.719616,548401.740128209,1138603.7662552,65.819091796875,40,1.81835188539793,-1.09064306313153 +-144.07146,59.8655599,13.719616,552105.692691419,1138603.76011364,72.3171615600586,40,1.85924137179536,-0.942120777514734 +-144.00585,59.8606104,13.719616,555809.619992978,1138603.74665269,82.6982803344727,40,1.91749647873012,-0.730521601464712 +-143.94026,59.8556286,13.719616,559513.527181493,1138603.7362739,94.1698303222656,40,1.97391178789693,-0.525605096038515 +-143.87468,59.8506144,13.719616,563217.974684324,1138603.80208982,113.904724121094,40,2.05654173652139,-0.22546953769905 +-143.80913,59.8455679,13.719616,566921.863758074,1138603.78547351,137.314880371094,141,2.13771760288048,0.0693843788161948 +-143.7436,59.8404891,13.719616,570625.753122152,1138603.77006575,181.434097290039,240,2.25871890826625,0.508895657188327 +-143.67809,59.835378,13.719616,574329.649560829,1138603.75527354,263.963623046875,240,2.42154408066321,1.10032315826526 +-143.6126,59.8302346,13.719616,578033.559853537,1138603.74052013,315.591125488281,240,2.49912478222541,1.38211841007598 +-143.54712,59.8250589,13.719616,581738.042705178,1138603.81284157,297.543914794922,240,2.47355107273891,1.28922739775758 +-143.48167,59.819851,13.719616,585441.999260984,1138603.80810119,292.195892333984,240,2.4656741063648,1.26061600757678 +-143.41624,59.8146109,13.719616,589145.988183415,1138603.81280443,290.214813232422,240,2.46271957605799,1.24988431019557 +-143.35083,59.8093385,13.719616,592850.017985193,1138603.81539469,280.894775390625,240,2.44854366145105,1.19839334213428 +-143.28545,59.8040339,13.719616,596553.541694452,1138603.73658626,241.235885620117,240,2.38244191278633,0.958292923666534 +-143.22008,59.7986971,13.719616,600257.66988913,1138603.75499127,186.484756469727,141,2.27064333774446,0.552208588624195 +-143.15473,59.7933281,13.719616,603961.857351148,1138603.78087098,181.511215209961,141,2.25890346437665,0.509566017658869 +-143.08941,59.787927,13.719616,607665.557028448,1138603.73330382,170.371887207031,141,2.23139793410372,0.409658080847605 +-143.0241,59.7824938,13.719616,611369.879451336,1138603.79429089,186.751068115234,141,2.27126309442439,0.554459721781876 +-142.95882,59.7770284,13.719616,615073.729274348,1138603.76881791,196.297470092773,141,2.29291470239253,0.633104541906334 +-142.89356,59.7715309,13.719616,618777.663258343,1138603.75900698,191.854141235352,240,2.28297117802613,0.596986823243162 +-142.82832,59.7660012,13.719616,622481.68992998,1138603.75343835,199.543838500977,240,2.30003832221606,0.658979562388951 +-142.7631,59.7604395,13.719616,626185.812204709,1138603.77378443,194.503189086914,240,2.28892672644062,0.618619074967349 +-142.6979,59.7548458,13.719616,629890.03669412,1138603.81967626,203.129165649414,240,2.30777228466143,0.687071521483178 +-142.63273,59.74922,13.719616,633593.81997904,1138603.7843365,210.956878662109,240,2.32419369097077,0.746718756334688 +-142.56758,59.7435621,13.719616,637297.720623454,1138603.76172266,238.782455444336,141,2.37800241381568,0.942167396245975 +-142.50245,59.7378722,13.719616,641001.743329403,1138603.76253392,184.697494506836,141,2.26646100410707,0.537017159096355 +-142.43734,59.7321504,13.719616,644705.89275048,1138603.79747747,176.688461303711,141,2.24720818869323,0.467085438212643 +-142.37226,59.7263965,13.719616,648409.627405307,1138603.74659785,157.22673034668,141,2.19652638302138,0.282994653984943 +-142.30719,59.7206107,13.719616,652114.053849649,1138603.82635884,168.279373168945,141,2.22603088562583,0.390163428867764 +-142.24216,59.7147929,13.719616,655817.524804486,1138603.73090656,167.415924072266,141,2.22379676433706,0.382048462665271 +-142.17714,59.7089431,13.719616,659521.702630328,1138603.7545775,165.202239990234,141,2.21801593165751,0.361050828359191 +-142.11214,59.7030615,13.719616,663226.037978878,1138603.82095691,158.218078613281,141,2.19925610617432,0.292909787616978 +-142.04717,59.6971479,13.719616,666929.989417529,1138603.80739151,152.589736938477,141,2.18352532430774,0.235771097865393 +-141.98223,59.6912025,13.719616,670633.559474485,1138603.73400976,140.728210449219,141,2.14838116505635,0.10811748032263 +-141.9173,59.6852252,13.719616,674337.860517058,1138603.79102603,139.293792724609,141,2.14393176362056,0.0919559843222087 +-141.8524,59.679216,13.719616,678041.79519473,1138603.77574479,121.339805603027,141,2.08400329483087,-0.125721319609893 +-141.78752,59.673175,13.719616,681745.919897731,1138603.79998401,116.998161315918,141,2.0681790366468,-0.18319954202741 +-141.72267,59.6671022,13.719616,685449.6891627,1138603.76038156,101.215950012207,141,2.0052489557495,-0.411779557879759 +-141.65784,59.6609975,13.719616,689153.663447667,1138603.74791168,105.249710083008,141,2.0222209082177,-0.350132582237741 +-141.59303,59.6548611,13.719616,692857.845086842,1138603.7844372,92.4599761962891,141,1.96595377729348,-0.554510861992598 +-141.52825,59.6486929,13.719616,696561.690655777,1138603.75397637,92.0170211791992,40,1.96386816995925,-0.562086383122125 +-141.46349,59.642493,13.719616,700265.756431263,1138603.77119512,88.3608093261719,40,1.94625968506586,-0.626045426216869 +-141.39875,59.6362613,13.719616,703970.050929465,1138603.82503228,84.1932830810547,40,1.92527744497716,-0.702258911146613 +-141.33404,59.6299979,13.719616,707674.026533886,1138603.819849,86.5502471923828,40,1.9372683125827,-0.658704657468943 +-141.26936,59.6237028,13.719616,711377.689640392,1138603.75392221,91.149040222168,40,1.95975209999691,-0.57703712406867 +-141.2047,59.617376,13.719616,715081.598569546,1138603.73321881,94.4666290283203,141,1.97527841815583,-0.520641104863065 +-141.14006,59.6110176,13.719616,718785.757554097,1138603.76869168,97.2546463012695,141,1.98791035873605,-0.474758291160887 +-141.07545,59.6046275,13.719616,722489.623173023,1138603.74056758,116.59260559082,141,2.06667100794499,-0.18867713270661 +-141.01086,59.5982058,13.719616,726193.751556673,1138603.76749981,143.903594970703,141,2.15807164352964,0.143316064075513 +-140.9463,59.5917525,13.719616,729897.597110134,1138603.73960001,187.122665405273,141,2.27212639500545,0.557595475902798 +-140.88176,59.5852676,13.719616,733601.71809343,1138603.76569116,222.17594909668,240,2.34669704407411,0.828457357902489 +-140.81725,59.5787511,13.719616,737305.568900152,1138603.73479871,254.481307983398,240,2.40565588829246,1.04261270863308 +-140.75276,59.572203,13.719616,741009.707778771,1138603.75689032,266.538604736328,240,2.42576011996576,1.11563701638955 +-140.6883,59.5656234,13.719616,744713.58688491,1138603.73086312,263.474456787109,240,2.42073851778718,1.09739712396898 +-140.62386,59.5590123,13.719616,748417.764423508,1138603.76782281,252.803405761719,240,2.40278292045512,1.0321772694212 +-140.55945,59.5523697,13.719616,752121.694733009,1138603.75461545,241.980285644531,240,2.38377998505252,0.963153184061193 +-140.49506,59.5456956,13.719616,755825.936006679,1138603.80349106,234.888259887695,240,2.37086131054768,0.916228870902826 +-140.4307,59.5389901,13.719616,759529.940302404,1138603.8111582,223.907089233398,240,2.35006784420969,0.840701066117068 +-140.36637,59.5322531,13.719616,763233.716118963,1138603.76513178,217.21418762207,240,2.33688818834197,0.7928287941572 +-140.30206,59.5254846,13.719616,766937.82163193,1138603.77937807,195.016662597656,240,2.29007171990128,0.622778018030134 +-140.23778,59.5186848,13.719616,770641.706549062,1138603.75991104,196.925094604492,141,2.29430106278017,0.638140198540913 +-140.17352,59.5118535,13.719616,774345.933592889,1138603.79994713,174.951309204102,141,2.24291719676456,0.451499330756705 +-140.10929,59.5049909,13.719616,778049.952416929,1138603.80440419,153.293212890625,142,2.18552292674347,0.243026960084467 +-140.04509,59.498097,13.719616,781753.769179103,1138603.77180829,155.257965087891,142,2.19105388971809,0.263116996302278 +-139.98091,59.4911717,13.719616,785457.944304594,1138603.80803838,120.51636505127,142,2.08104602424607,-0.136462970462952 +-139.91676,59.4842151,13.719616,789161.929687257,1138603.80542984,100.361236572266,40,2.00156600371076,-0.425157090903642 +-139.85264,59.4772272,13.719616,792865.731467022,1138603.76255081,85.2682571411133,40,1.93078738621852,-0.682245231864176 +-139.78854,59.470208,13.719616,796569.907708105,1138603.7979288,67.747688293457,40,1.83089448067524,-1.04508477707124 +-139.72447,59.4631576,13.719616,800273.910222941,1138603.80225398,22,40,1.34242268082221,-2.81935377786993 +-147.31466,60.0352201,13.71918016,370609.787291742,1134899.77286189,33.9653358459473,33,1.5310359132097,-2.13425668226225 +-147.2483,60.0318752,13.719616,374313.877922301,1134899.78181099,169.360397338867,140,2.22881186391709,0.400264735791853 +-147.18196,60.0284974,13.719616,378017.610607646,1134899.75658702,220.577301025391,140,2.34356081840956,0.81706569112091 +-147.11563,60.0250867,13.719616,381721.545029911,1134899.75320759,223.44873046875,140,2.34917789154512,0.837468504021573 +-147.04931,60.021643,13.719616,385425.689548108,1134899.76078041,121.091575622559,140,2.0831139301959,-0.128951745814062 +-146.983,60.0181665,13.719616,389130.049023864,1134899.80179914,87.8780822753906,140,1.94388057093506,-0.634687047806739 +-146.91672,60.0146571,13.719616,392833.526822045,1134899.74710208,142.608062744141,140,2.15414408025849,0.129050033236546 +-146.85044,60.0111148,13.719616,396537.787587151,1134899.77275494,139.513290405273,140,2.14461558162208,0.0944398064848118 +-146.78418,60.0075397,13.719616,400241.732307038,1134899.77131482,125.321578979492,140,2.0980258581037,-0.0747873673649412 +-146.71793,60.0039317,13.719616,403945.921833537,1134899.79113235,115.413993835449,140,2.06225846979943,-0.204704730715083 +-146.6517,60.0002909,13.719616,407649.809613271,1134899.78227616,82.5452651977539,140,1.91669216715106,-0.733443090693256 +-146.58548,59.9966172,13.719616,411353.956513063,1134899.79425009,69.7949829101562,41,1.84382420524858,-0.998120326910048 +-146.51928,59.9929107,13.719616,415057.815950109,1134899.77604008,70.7109069824219,41,1.849486407813,-0.977553591042584 +-146.45309,59.9891714,13.719616,418761.947537932,1134899.78941447,63.3716316223145,41,1.80189488900066,-1.15041957134086 +-146.38692,59.9853994,13.719616,422465.804630991,1134899.78227252,63.955192565918,41,1.80587581091281,-1.13595972668769 +-146.32076,59.9815945,13.719616,426169.949382749,1134899.79531176,68.6700286865234,41,1.83676722881835,-1.02375327956626 +-146.25462,59.9777568,13.719616,429873.835151256,1134899.7753523,65.3410873413086,41,1.81518635729585,-1.10214116472999 +-146.18849,59.9738864,13.719616,433578.020222661,1134899.79756956,67.8365631103516,41,1.83146383659506,-1.04301671386009 +-146.12238,59.9699833,13.719616,437281.959182391,1134899.79658785,72.5388259887695,41,1.86057052242273,-0.937292923058751 +-146.05629,59.9660474,13.719616,440985.660434617,1134899.7601169,80.7817916870117,41,1.90731348130678,-0.767509154623147 +-145.99021,59.9620788,13.719616,444689.682220812,1134899.76505362,80.1225738525391,41,1.90375489209434,-0.780434966365215 +-145.92414,59.9580774,13.719616,448394.032959479,1134899.80081837,80.5087738037109,41,1.90584321213061,-0.772849591927575 +-145.8581,59.9540434,13.719616,452097.612030311,1134899.75400108,83.5489273071289,41,1.92194087831576,-0.714378273611741 +-145.79207,59.9499767,13.719616,455801.532809045,1134899.74797581,86.4315185546875,41,1.93667214338452,-0.66087011416034 +-145.72605,59.9458772,13.719616,459505.803735427,1134899.77221889,83.7477645874023,41,1.92297322358575,-0.710628500930477 +-145.66005,59.9417452,13.719616,463209.875198345,1134899.79086157,81.3185272216797,41,1.9101895044312,-0.757062617736498 +-145.59407,59.9375804,13.719616,466913.758408873,1134899.76954821,76.9458541870117,41,1.88618522517844,-0.844253011485969 +-145.5281,59.933383,13.719616,470618.010080553,1134899.80028369,77.6112213134766,41,1.88992451767832,-0.830670833826071 +-145.46216,59.929153,13.719616,474321.532238016,1134899.7408613,83.6899337768555,41,1.9226732242051,-0.711718184309339 +-145.39622,59.9248904,13.719616,478025.989342148,1134899.80452884,92.4661254882812,41,1.96598266022084,-0.554405950956425 +-145.33031,59.9205951,13.719616,481729.73237703,1134899.76493041,100.048515319824,140,2.00021064826267,-0.430080128748069 +-145.26441,59.9162673,13.719616,485433.870406594,1134899.78777662,116.823181152344,140,2.06752902811578,-0.185560558542962 +-145.19853,59.9119069,13.719616,489137.859371693,1134899.78903066,141.872344970703,140,2.15189774713376,0.120890710160233 +-145.13267,59.9075139,13.719616,492841.706252238,1134899.76774216,153.828033447266,140,2.18703548801437,0.248521014348362 +-145.06682,59.9030883,13.719616,496545.970511953,1134899.79774621,167.537872314453,140,2.22411299571925,0.383197105306792 +-145.001,59.8986302,13.719616,500249.552635309,1134899.74022763,195.282043457031,140,2.29066231094759,0.624923213281791 +-144.93519,59.8941396,13.719616,503953.564532553,1134899.74437718,215.800003051758,140,2.33405144648851,0.782524938058693 +-144.86939,59.8896165,13.719616,507658.013133455,1134899.81098084,211.055450439453,140,2.32439657215123,0.747455678690207 +-144.80362,59.8850608,13.719616,511361.801930934,1134899.77576636,198.086242675781,140,2.29685431431964,0.647414336902814 +-144.73786,59.8804727,13.719616,515066.039745815,1134899.81347505,148.733489990234,140,2.17240876865885,0.195392594767748 +-144.67213,59.8758521,13.719616,518769.630051249,1134899.75763574,77.8031692504883,140,1.89099728799182,-0.826774225848311 +-144.60641,59.871199,13.719616,522473.684735542,1134899.76310058,44.2413215637207,41,1.6458280916072,-1.71729872537281 +-144.40936,59.8570451,13.719616,533585.935238,1134899.79863893,33,40,1.51851393987789,-2.17974006353042 +-144.34372,59.8522623,13.719616,537289.701612389,1134899.76497113,53.7100410461426,40,1.73005548427098,-1.4113607943266 +-144.27809,59.8474471,13.719616,540993.965161887,1134899.80371531,63.3295631408691,40,1.80160649219337,-1.1514671108616 +-144.21249,59.8425995,13.719616,544697.627762454,1134899.75178134,69.0855178833008,40,1.83938701752551,-1.01423745921971 +-144.1469,59.8377195,13.719616,548401.801237736,1134899.7719412,77.4696197509766,40,1.88913142429694,-0.833551575358606 +-144.08133,59.8328072,13.719616,552105.938278488,1134899.79309992,83.6772842407227,40,1.92260757665695,-0.711956634941887 +-144.01578,59.8278626,13.719616,555810.045690128,1134899.8145769,95.1630935668945,40,1.97846855166277,-0.509053629411107 +-143.95026,59.8228856,13.719616,559513.579471127,1134899.74040276,104.563987731934,40,2.01938213747369,-0.360443807845804 +-143.88475,59.8178763,13.719616,563217.649729636,1134899.74893059,111.764343261719,40,2.04830327050364,-0.255393997767811 +-143.81926,59.8128348,13.719616,566921.709061232,1134899.76688828,135.666946411133,141,2.13247405001921,0.0503382981650748 +-143.75379,59.8077609,13.719616,570625.767656733,1134899.77155551,151.168731689453,141,2.17946196934597,0.221011832847274 +-143.68834,59.8026548,13.719616,574329.828871719,1134899.78443512,231.538238525391,240,2.36462272498332,0.893568547463446 +-143.62291,59.7975164,13.719616,578033.901190678,1134899.79389273,298.145874023438,240,2.47442880361551,1.29241556683074 +-143.5575,59.7923458,13.719616,581737.989634479,1134899.81040671,313.088317871094,340,2.49566686327718,1.36955826146766 +-143.49212,59.7871429,13.719616,585441.550211581,1134899.73422425,306.207336425781,340,2.48601559175435,1.33450208854962 +-143.42675,59.7819079,13.719616,589145.691114595,1134899.76264466,304.657104492188,340,2.48381131016696,1.32649550865962 +-143.3614,59.7766406,13.719616,592849.870115057,1134899.78546379,313.067657470703,240,2.49563820365165,1.36945416152749 +-143.29608,59.7713412,13.719616,596553.537888035,1134899.73442781,290.439483642578,240,2.46305565597602,1.25110504838459 +-143.23077,59.7660096,13.719616,600257.807897375,1134899.77710143,235.724884033203,240,2.37240543075459,0.921837556230087 +-143.16549,59.7606459,13.719616,603961.580060441,1134899.74383096,189.022964477539,141,2.27651456999344,0.57353457996904 +-143.10022,59.75525,13.719616,607665.967852785,1134899.80444758,183.782699584961,141,2.26430462659081,0.529184580465863 +-143.03498,59.749822,13.719616,611369.871160038,1134899.78709488,177.731521606445,141,2.24976445901353,0.476370541648168 +-142.96976,59.7443619,13.719616,615073.849132448,1134899.78228301,189.344268798828,141,2.27725216413489,0.576213732421087 +-142.90456,59.7388698,13.719616,618777.906567499,1134899.80062184,196.362518310547,240,2.29305859320457,0.633627194406219 +-142.83938,59.7333455,13.719616,622482.053825604,1134899.81965456,201.129425048828,240,2.30347561212584,0.671464780441489 +-142.77423,59.7277892,13.719616,626185.741335509,1134899.76675824,206.363311767578,240,2.31463248891848,0.711989741442027 +-142.7091,59.7222009,13.719616,629889.528194557,1134899.73473156,236.225509643555,240,2.37332679462899,0.925184212805357 +-142.64398,59.7165805,13.719616,633593.975397809,1134899.80760034,276.489166259766,240,2.44167811891095,1.17345573200771 +-142.57889,59.7109281,13.719616,637297.982686785,1134899.80579183,275.102111816406,141,2.43949392425625,1.1655221135906 +-142.51383,59.7052438,13.719616,641001.554730756,1134899.73832009,212.162887573242,141,2.32666941758719,0.755711302048286 +-142.44878,59.6995274,13.719616,644705.80693244,1134899.77532221,178.694854736328,141,2.25211204779501,0.484897654171046 +-142.38376,59.6937791,13.719616,648409.637039233,1134899.74493187,183.268936157227,141,2.26308885885867,0.524768565048079 +-142.31876,59.6879989,13.719616,652113.604084808,1134899.74338195,194.448959350586,141,2.28880562323813,0.618179193569621 +-142.25378,59.6821867,13.719616,655817.716577012,1134899.75939255,211.402877807617,240,2.32511089502184,0.750050303244289 +-142.18882,59.6763426,13.719616,659521.979104816,1134899.80371887,201.581420898438,141,2.3044505021132,0.675005859136883 +-142.12389,59.6704667,13.719616,663225.843720719,1134899.7872569,188.039535522461,141,2.27424916976424,0.565305999726975 +-142.05898,59.6645588,13.719616,666929.873404432,1134899.7865222,174.851165771484,141,2.2426685321925,0.450596110055048 +-141.9941,59.6586191,13.719616,670633.518197896,1134899.72232794,157.666442871094,141,2.19773926957047,0.287400204123507 +-141.92923,59.6526476,13.719616,674337.889558495,1134899.79587971,146.593719482422,141,2.16611536421673,0.17253315351751 +-141.86439,59.6466442,13.719616,678041.891017929,1134899.79347323,137.906951904297,141,2.13958615955928,0.0761715100127625 +-141.79958,59.640609,13.719616,681745.527036003,1134899.72426454,132.251693725586,141,2.1214012426805,0.010118701416991 +-141.73478,59.634542,13.719616,685449.909053775,1134899.79285118,130.754409790039,141,2.11645634469178,-0.00784257949244207 +-141.67001,59.6284433,13.719616,689153.93649031,1134899.80421394,119.452354431152,141,2.07719471420629,-0.150452027800785 +-141.60527,59.6223128,13.719616,692857.617842268,1134899.74556013,110.959457397461,141,2.04516432432816,-0.266795546221595 +-141.54054,59.6161505,13.719616,696562.064534156,1134899.82487899,107.766456604004,141,2.03248360334864,-0.312855544257322 +-141.47585,59.6099565,13.719616,700265.623448251,1134899.73839966,104.284049987793,141,2.01821788913607,-0.364672690117628 +-141.41117,59.6037309,13.719616,703969.956346905,1134899.8116766,100.274398803711,40,2.00119006684403,-0.426522600906677 +-141.34652,59.5974735,13.719616,707673.968856792,1134899.81122651,107.418090820312,40,2.03107742923878,-0.317963169986406 +-141.2819,59.5911844,13.719616,711377.665275533,1134899.7463032,112.571571350098,141,2.05142872830733,-0.244041442930348 +-141.2173,59.5848637,13.719616,715081.602340466,1134899.73384209,115.938087463379,141,2.06422613188992,-0.197557620375738 +-141.15272,59.5785114,13.719616,718785.786402203,1134899.77380976,133.49299621582,141,2.12545848079713,0.024855748307643 +-141.08817,59.5721275,13.719616,722489.671317632,1134899.75739688,169.022048950195,141,2.22794336208584,0.397110089245655 +-141.02364,59.5657119,13.719616,726193.818085113,1134899.78130546,199.280288696289,141,2.299464343689,0.656894708548876 +-140.95914,59.5592648,13.719616,729897.676218793,1134899.75758045,220.989028930664,240,2.34437071353514,0.820007461384109 +-140.89466,59.5527861,13.719616,733601.806694945,1134899.7840665,251.505004882812,240,2.4005466318228,1.02405443080832 +-140.83021,59.5462758,13.719616,737305.663347577,1134899.74978201,278.315063476562,240,2.44453671264992,1.18383896039151 +-140.76578,59.539734,13.719616,741009.802767534,1134899.77564799,278.09619140625,240,2.44419504113825,1.18259791193838 +-140.70138,59.5331607,13.719616,744713.678745366,1134899.74958997,271.820678710938,240,2.43428249253056,1.14659270607219 +-140.637,59.5265559,13.719616,748417.850041999,1134899.78270646,261.299346923828,240,2.41713832427868,1.08432019354855 +-140.57265,59.5199197,13.719616,752121.76819098,1134899.77279025,253.688812255859,240,2.40430131514179,1.0376925123162 +-140.50832,59.513252,13.719616,755825.994165758,1134899.82112588,247.29753112793,240,2.39321978064408,0.997441216035643 +-140.44402,59.5065528,13.719616,759529.981733591,1134899.8134655,241.733413696289,240,2.38333668508267,0.961542992040284 +-140.37975,59.4998222,13.719616,763233.734866726,1134899.75921766,237.305191040039,240,2.37530723849288,0.93237775019396 +-140.3155,59.4930603,13.719616,766937.809977237,1134899.78327965,226.882080078125,240,2.35580019517747,0.861522601007903 +-140.25128,59.4862669,13.719616,770641.665347878,1134899.74787435,220.822189331055,240,2.34404271135719,0.818816063852633 +-140.18708,59.4794422,13.719616,774345.855080556,1134899.78998569,206.122360229492,240,2.31412510676,0.710146784621155 +-140.12291,59.4725861,13.719616,778049.835168968,1134899.78169664,176.281890869141,142,2.2462077002769,0.463451378716701 +-140.05877,59.4656987,13.719616,781753.609471098,1134899.73246866,193.998138427734,142,2.2877975625362,0.614517629371022 +-139.99465,59.45878,13.719616,785457.736625399,1134899.75910666,173.202743530273,142,2.23855476695744,0.435653740535783 +-139.93056,59.4518301,13.719616,789161.667937042,1134899.75393212,149.778564453125,142,2.17544966379172,0.206437993848202 +-139.86649,59.4448488,13.719616,792865.966724213,1134899.81302835,131.788269042969,142,2.11987675383426,0.00458132279501027 +-139.80246,59.4378363,13.719616,796569.529430303,1134899.71861296,116.059173583984,142,2.06467947378328,-0.195910953222386 +-139.73844,59.4307926,13.719616,800274.019614257,1134899.82910361,94.9395217895508,40,1.97744703984619,-0.512764051897425 +-139.67446,59.4237176,13.719616,803977.788293752,1134899.77233761,70.1851654052734,40,1.84624532775022,-0.989326118926951 +-139.6105,59.4166115,13.719616,807681.941751577,1134899.81033462,45.8153533935547,40,1.66101104081435,-1.66214992020726 +-139.54657,59.4094742,11.67178313,811385.935958889,1134899.81029013,11,40,1.04139268515823,-3.91278064463658 +-149.38242,60.0894928,11.95206456,255785.657663421,1131195.76640779,163.526580810547,33,2.21358835614664,0.344968610347845 +-147.32136,60.0022675,13.719616,370609.603099631,1131195.75921745,32.5954818725586,33,1.51315740577953,-2.19919652428271 +-147.25506,59.9989259,13.719616,374314.001330827,1131195.79818267,118.097038269043,140,2.07223900616948,-0.168452573890355 +-147.18878,59.9955514,13.719616,378018.03939226,1131195.79982944,191.790786743164,140,2.28282774067245,0.596465817833501 +-147.12252,59.9921441,13.719616,381721.723318627,1131195.77381621,197.159576416016,140,2.29481787643144,0.640017413235607 +-147.05627,59.9887038,13.719616,385425.615644182,1131195.75448382,180.467727661133,140,2.25639954999902,0.500471085950981 +-146.99003,59.9852307,13.719616,389129.721229643,1131195.76432175,147.164306640625,140,2.16780248861065,0.178661270869462 +-146.9238,59.9817248,13.719616,392834.047222232,1131195.80358787,145.577499389648,140,2.16309425515523,0.16155962309574 +-146.85759,59.978186,13.719616,396538.048920356,1131195.80172916,132.287582397461,140,2.12151907964204,0.0105467188953377 +-146.7914,59.9746144,13.719616,400241.732285996,1131195.76848676,64.2958068847656,140,1.80818265089953,-1.12758062541824 +-146.72522,59.97101,13.719616,403945.657501696,1131195.76332327,60.5656929016113,41,1.78222669013064,-1.22186008349963 +-146.65905,59.9673727,13.719616,407649.832934293,1131195.7754519,71.3277435302734,41,1.85325848523123,-0.963852329201469 +-146.5929,59.9637027,13.719616,411353.710211271,1131195.76550948,72.0599670410156,41,1.8576940591478,-0.947741058697657 +-146.52676,59.9599999,13.719616,415057.850726981,1131195.78356819,64.6093902587891,41,1.81029564247195,-1.11990563691938 +-146.46064,59.9562643,13.719616,418761.708557903,1131195.766953,64.5388107299805,41,1.80982095830734,-1.12162982529359 +-146.39453,59.9524959,13.719616,422465.843868448,1131195.77800298,68.8393630981445,41,1.83783684358113,-1.01986813344939 +-146.32844,59.9486948,13.719616,426169.709438696,1131195.76407142,67.153434753418,41,1.82706823079933,-1.058982808741 +-146.26236,59.944861,13.719616,429873.865392432,1131195.78864393,71.3898696899414,41,1.85363658922865,-0.96247894756124 +-146.1963,59.9409944,13.719616,433577.767069143,1131195.77577432,69.63916015625,41,1.84285352491362,-1.00164611494638 +-146.13025,59.9370951,13.719616,437281.973296069,1131195.80120728,80.1065673828125,41,1.90366812234139,-0.780750138874479 +-146.06422,59.933163,13.719616,440985.939427149,1131195.78791854,85.0979309082031,41,1.92991900067126,-0.685399456033738 +-145.99821,59.9291983,13.719616,444689.669869828,1131195.75694232,85.8489379882812,41,1.9337349270021,-0.671538922426334 +-145.93221,59.9252009,13.719616,448393.726050897,1131195.76353485,89.1984710693359,41,1.95035741029718,-0.611161318569483 +-145.86623,59.9211709,13.719616,452097.560613218,1131195.75125357,90.5099182128906,41,1.95669617245507,-0.588137125149189 +-145.80026,59.9171081,13.719616,455801.736375091,1131195.7654093,85.4485855102539,41,1.93170487793825,-0.678912640059894 +-145.73431,59.9130127,13.719616,459505.704594187,1131195.75957656,79.9596786499023,41,1.9028710400627,-0.783645369220585 +-145.66837,59.9088847,13.719616,463210.025326275,1131195.80241224,73.6490020751953,41,1.86716686664135,-0.913333118072641 +-145.60246,59.9047241,13.719616,466913.599485684,1131195.75390134,76.4528045654297,41,1.88339342153316,-0.854393639185713 +-145.53656,59.9005308,13.719616,470617.541587267,1131195.7419492,80.3760452270508,41,1.90512663362608,-0.775452409587923 +-145.47067,59.896305,13.719616,474321.855797199,1131195.78937468,78.7293548583984,41,1.8961366926641,-0.808106441146431 +-145.4048,59.8920465,13.719616,478025.998917039,1131195.80266407,88.6552505493164,41,1.94770446150569,-0.62079758580718 +-145.33895,59.8877555,13.719616,481729.975060705,1131195.80299144,94.6201782226562,41,1.97598376173245,-0.518079095667678 +-145.27312,59.8834319,13.719616,485433.792645952,1131195.77827621,108.483612060547,140,2.03536413699356,-0.302392623872819 +-145.2073,59.8790757,13.719616,489138.011699814,1131195.80119893,138.458618164062,140,2.14131999297875,0.0824692878775864 +-145.14151,59.8746871,13.719616,492841.530133103,1131195.74622309,155.337554931641,140,2.19127646492272,0.263925452974781 +-145.07572,59.8702658,13.719616,496546.018484905,1131195.80178683,174.975357055664,140,2.24297688841004,0.451716147850749 +-145.00996,59.8658121,13.719616,500249.82009149,1131195.77758271,200.233322143555,140,2.30153635295771,0.66442083762316 +-144.94421,59.8613259,13.719616,503954.049463021,1131195.8117125,211.211776733398,140,2.3247181299022,0.748623668223439 +-144.87849,59.8568072,13.719616,507657.607434807,1131195.75207332,201.609420776367,140,2.30451082189848,0.675224957814003 +-144.81278,59.852256,13.719616,511361.607021056,1131195.75011523,165.578643798828,140,2.21900432110568,0.364640940949393 +-144.74708,59.8476724,13.719616,515066.053586904,1131195.81772712,93.3047027587891,140,1.9699035336792,-0.540164219426958 +-144.68141,59.8430563,13.719616,518769.849485687,1131195.78843227,61.1126518249512,41,1.78613112921084,-1.20767804632248 +-144.61576,59.8384077,13.719616,522473.554672577,1131195.73840473,21.3515529632568,41,1.32942946806574,-2.86654883523357 +-144.4845,59.8290134,13.68541582,529881.820230052,1131195.7767826,34,40,1.53147891704226,-2.13264756589653 +-144.4189,59.8242677,13.719616,533585.841263635,1131195.78549269,60.7335014343262,40,1.78342831997932,-1.21749542090991 +-144.35332,59.8194895,13.719616,537289.799090389,1131195.77143741,69.9747085571289,40,1.84494109831656,-0.994063452494141 +-144.28776,59.8146791,13.719616,540993.695708261,1131195.76706487,75.1809158325195,40,1.87610761186179,-0.880857779489239 +-144.22222,59.8098362,13.719616,544697.542822726,1131195.73844909,82.4298400878906,40,1.91608445732261,-0.735650466247857 +-144.15669,59.804961,13.719616,548401.897054277,1131195.78957805,89.0029602050781,40,1.94940445135672,-0.614622737442795 +-144.09119,59.8000535,13.719616,552105.659118714,1131195.75515307,97.4871215820312,40,1.98894724754189,-0.470992015060566 +-144.0257,59.7951137,13.719616,555809.941910447,1131195.80019937,105.46541595459,40,2.02311006984769,-0.34690289340562 +-143.96024,59.7901416,13.719616,559513.646135951,1131195.75722002,109.80248260498,40,2.04061215950802,-0.283330308165566 +-143.89479,59.7851372,13.719616,563217.884680247,1131195.79350391,122.230308532715,141,2.08717890800501,-0.114186586151181 +-143.82937,59.7801005,13.719616,566921.558240369,1131195.73935582,129.5341796875,141,2.11238437915921,-0.0226331205614148 +-143.76396,59.7750316,13.719616,570625.777975053,1131195.77537825,150.911804199219,141,2.1787232112672,0.218328452642619 +-143.69857,59.7699304,13.719616,574329.999312616,1131195.80510511,184.707473754883,240,2.26648446850379,0.53710238848262 +-143.63321,59.764797,13.719616,578033.674243007,1131195.75195571,282.723388671875,240,2.45136173756972,1.20862939895631 +-143.56786,59.7596315,13.719616,581737.913845292,1131195.79991735,319.397613525391,340,2.50433166685373,1.40103130123887 +-143.50254,59.7544337,13.719616,585441.622247786,1131195.7517016,308.331481933594,340,2.48901787027308,1.34540722106526 +-143.43723,59.7492037,13.719616,589145.910530705,1131195.79356059,309.192596435547,340,2.49022908626284,1.34980670325549 +-143.37195,59.7439416,13.719616,592849.677542655,1131195.7591385,306.331268310547,340,2.48619132903525,1.33514041651425 +-143.30668,59.7386473,13.719616,596554.037852825,1131195.8148606,308.190032958984,240,2.48881858927887,1.34468337561381 +-143.24144,59.7333209,13.719616,600257.890278266,1131195.79216852,278.271453857422,240,2.44446865704167,1.18359176299736 +-143.17622,59.7279624,13.719616,603961.794539628,1131195.77984537,224.177169799805,240,2.35059138196626,0.842602704681479 +-143.11102,59.7225717,13.719616,607665.759132079,1131195.76638785,178.659515380859,141,2.25202615161795,0.484585654738759 +-143.04584,59.717149,13.719616,611369.787080641,1131195.77340795,172.913955688477,141,2.23783004610161,0.433021347531485 +-142.98068,59.7116942,13.719616,615073.886859592,1131195.78943229,194.489761352539,141,2.28889674342453,0.618510168094908 +-142.91554,59.7062074,13.719616,618778.063265882,1131195.82506469,203.037536621094,240,2.30757633564919,0.686359778741317 +-142.85043,59.7006885,13.719616,622481.771739476,1131195.77513529,217.652481079102,240,2.3377636221611,0.796008619661965 +-142.78534,59.6951376,13.719616,626185.570091313,1131195.74289193,249.465316772461,240,2.39701017408216,1.01120900688875 +-142.72026,59.6895546,13.719616,629890.019864353,1131195.81177867,286.169891357422,240,2.45662393862996,1.2277432151888 +-142.65521,59.6839397,13.719616,633594.01779922,1131195.81433787,356.826721191406,241,2.55245736933483,1.57583758909328 +-142.59019,59.6782928,13.719616,637297.572371934,1131195.7375227,341.897918701172,241,2.53389645704302,1.50841905783763 +-142.52518,59.6726139,13.719616,641001.796265559,1131195.77236587,230.352813720703,141,2.36239352145482,0.885471443969921 +-142.4602,59.6669031,13.719616,644705.588041362,1131195.73707919,180.946823120117,141,2.25755096261131,0.504653345204708 +-142.39523,59.6611604,13.719616,648410.060339607,1131195.82495171,212.510055541992,141,2.32737948480081,0.758290468841515 +-142.3303,59.6553857,13.719616,652113.562521085,1131195.73177194,244.131530761719,240,2.38762387426146,0.977115286823291 +-142.26538,59.6495792,13.719616,655817.756362418,1131195.7721909,225.445709228516,240,2.35304197405771,0.851503954626229 +-142.20049,59.6437407,13.719616,659521.546225202,1131195.72698246,206.155090332031,240,2.31419406276492,0.710397252513029 +-142.13561,59.6378704,13.719616,663226.040786589,1131195.81597346,190.285202026367,141,2.27940501567442,0.584033503697672 +-142.07077,59.6319683,13.719616,666929.587398999,1131195.73932528,176.373672485352,141,2.24643375796322,0.464272484756717 +-142.00594,59.6260343,13.719616,670633.853692961,1131195.78541491,162.928176879883,141,2.21199619790733,0.339185437175472 +-141.94114,59.6200685,13.719616,674337.738068878,1131195.76363197,156.474395751953,141,2.1944432831389,0.275428240635884 +-141.87636,59.6140709,13.719616,678041.800046274,1131195.77420835,151.684432983398,141,2.18094101245243,0.226384139570861 +-141.8116,59.6080416,13.719616,681746.044052695,1131195.82796083,141.408828735352,141,2.15047652509984,0.115728426075851 +-141.74687,59.6019804,13.719616,685449.927575921,1131195.7995233,144.366409301758,141,2.15946615478534,0.148381326989373 +-141.68216,59.5958875,13.719616,689154.006026922,1131195.81283275,134.547561645508,141,2.12887583161671,0.0372685418933909 +-141.61748,59.5897629,13.719616,692857.732779626,1131195.76342218,123.673545837402,141,2.09227681259996,-0.0956695415755056 +-141.55282,59.5836066,13.719616,696561.667294069,1131195.7543815,123.321266174316,141,2.09103797510163,-0.10016935296885 +-141.48818,59.5774186,13.719616,700265.815978956,1131195.78560235,121.368492126465,141,2.08410595633036,-0.125348423741234 +-141.42357,59.5711988,13.719616,703969.634296525,1131195.74000741,123.08765411377,141,2.09021449469288,-0.10316046885813 +-141.35898,59.5649475,13.719616,707673.675375436,1131195.75535053,127.14973449707,141,2.10431545765701,-0.0519417465568965 +-141.29441,59.5586645,13.719616,711377.949796117,1131195.80959989,133.644256591797,141,2.12595029953785,0.026642174352987 +-141.22987,59.5523498,13.719616,715081.910899105,1131195.79503152,144.298645019531,141,2.15926225303872,0.147640697646306 +-141.16536,59.5460036,13.719616,718785.560769949,1131195.73188534,180.056030273438,141,2.2554076709482,0.496868298127926 +-141.10086,59.5396258,13.719616,722490.013969601,1131195.82506583,218.025955200195,141,2.33850819786716,0.798713131149444 +-141.0364,59.5332163,13.719616,726193.619866889,1131195.73722088,234.814804077148,240,2.37072547386323,0.915735473293227 +-140.97195,59.5267754,13.719616,729898.037424361,1131195.82763402,260.458709716797,240,2.41573888478157,1.07923702985527 +-140.90754,59.5203029,13.719616,733601.618147022,1131195.74466231,283.759521484375,240,2.45295044309544,1.21440003088741 +-140.84314,59.5137988,13.719616,737306.027492562,1131195.81805684,292.151153564453,240,2.46560760546979,1.26037445734488 +-140.77878,59.5072633,13.719616,741009.608215266,1131195.73672189,289.611053466797,240,2.46181513338155,1.24659911624109 +-140.71443,59.5006963,13.719616,744714.02791957,1131195.82281243,283.202819824219,240,2.45209757326915,1.21130216424504 +-140.65012,59.4940978,13.719616,748417.633739104,1131195.73998722,275.165649414062,240,2.43959421735035,1.16588640673486 +-140.58583,59.4874679,13.719616,752121.535787568,1131195.72244331,266.371276855469,240,2.42548739251137,1.11464639243102 +-140.52156,59.4808066,13.719616,755825.740292608,1131195.7702727,254.684921264648,240,2.40600323312455,1.04387436420532 +-140.45732,59.4741138,13.719616,759529.702694608,1131195.75826399,252.182525634766,240,2.4017149899162,1.02829824088614 +-140.3931,59.4673896,13.719616,763233.98001215,1131195.81074448,249.145431518555,240,2.39645292809358,1.0091849304044 +-140.32891,59.4606341,13.719616,766938.023123975,1131195.82331087,237.647476196289,240,2.37593320647069,0.934651444558403 +-140.26475,59.4538472,13.719616,770641.840498673,1131195.7834892,230.297180175781,240,2.36228862037155,0.885090413293708 +-140.20061,59.447029,13.719616,774345.989073682,1131195.81730921,220.7666015625,240,2.34393337225361,0.818418913019969 +-140.1365,59.4401795,13.719616,778049.921963876,1131195.80778477,209.807998657227,142,2.32182204108575,0.738104247016042 +-140.07242,59.4332986,13.719616,781753.647651762,1131195.74249099,209.276428222656,142,2.32072031448616,0.734102461542264 +-140.00836,59.4263865,13.719616,785457.720686974,1131195.76010023,192.077438354492,142,2.28347635510849,0.598821770598204 +-139.94433,59.4194431,13.719616,789161.596483725,1131195.7310567,178.932495117188,142,2.25268921797686,0.486994101012297 +-139.88032,59.4124685,13.719616,792865.831865288,1131195.78423074,161.708404541016,142,2.20873259226838,0.327331089969018 +-139.81634,59.4054627,13.719616,796569.87988507,1131195.79991057,151.081558227539,142,2.17921145541238,0.220101894736692 +-139.75239,59.3984256,13.719616,800273.749016686,1131195.76574558,136.268463134766,142,2.1343953578794,0.05731703670912 +-139.68846,59.3913574,13.719616,803977.99364284,1131195.82323648,119.783767700195,142,2.07839796933986,-0.146081461712442 +-139.62457,59.384258,13.719616,807681.516122914,1131195.718494,104.06859588623,142,2.0173196950155,-0.367935187533665 +-139.56069,59.3771274,13.719616,811385.98166939,1131195.81498936,89.9710388183594,40,1.95410273493375,-0.5975572304674 +-139.49685,59.3699657,13.719616,815089.734791376,1131195.75741143,57.500358581543,40,1.75967055302876,-1.30379041161617 +-139.43303,59.362773,13.39855415,818793.885179002,1131195.80021939,14,40,1.14612803567824,-3.53235195710261 +-149.38705,60.0564531,13.719616,255786.051044236,1127491.79925635,257.948089599609,33,2.41153231577428,1.06395757054646 +-149.05425,60.0445457,6.848100641,274305.769141044,1127491.76872127,110.123352050781,33,2.04187942243616,-0.278727247497707 +-147.32804,59.9693142,12.97539709,370609.787123021,1127491.77415771,13.6437206268311,33,1.13493281807427,-3.57301618287344 +-147.26181,59.9659759,13.719616,374313.932804735,1127491.78727603,55.9480018615723,33,1.74778458065902,-1.34696365585733 +-147.1956,59.9626048,13.719616,378017.714949395,1127491.76993415,190.240478515625,140,2.27930292966546,0.583662698174893 +-147.1294,59.9592008,13.719616,381721.695469694,1127491.76701453,203.700225830078,140,2.30899151047637,0.691500097644721 +-147.06321,59.955764,13.719616,385425.880383737,1127491.78986127,183.738693237305,140,2.26420062331688,0.528806810889445 +-146.99704,59.9522943,13.719616,389129.724412506,1127491.76899497,156.574356079102,140,2.19472063431639,0.276435659276417 +-146.93088,59.9487918,13.719616,392833.787148635,1127491.77327144,147.888458251953,140,2.16993428141352,0.186404550803735 +-146.86474,59.9452565,13.719616,396537.522129116,1127491.7432523,78.8321304321289,41,1.89670326349572,-0.806048494170579 +-146.7986,59.9416884,13.719616,400242.043698107,1127491.79808787,62.1461563110352,41,1.79341427304961,-1.18122358908387 +-146.73249,59.9380876,13.719616,403945.6969571,1127491.76839889,61.4407539367676,41,1.78845653626449,-1.19923150416639 +-146.66639,59.9344539,13.719616,407649.598674843,1127491.75169459,63.0956687927246,41,1.79999954808756,-1.15730399052138 +-146.6003,59.9307875,13.719616,411353.753523918,1127491.77054802,66.2917556762695,41,1.82145952106036,-1.07935524339809 +-146.53423,59.9270883,13.719616,415057.616244909,1127491.75170353,74.1323928833008,41,1.87000801872745,-0.903013242750387 +-146.46817,59.9233564,13.719616,418761.746294886,1127491.76803189,72.4536437988281,41,1.86006023165579,-0.93914644477576 +-146.40213,59.9195918,13.719616,422465.597152584,1127491.75630951,70.0774536132812,41,1.84557831259792,-0.991748908345192 +-146.3361,59.9157944,13.719616,426169.730787844,1127491.76833348,75.0157165527344,41,1.87515226201916,-0.884327882801662 +-146.27009,59.9119643,13.719616,429873.599406372,1127491.75091098,77.9330139160156,41,1.8917214721045,-0.824143782448323 +-146.20409,59.9081015,13.719616,433577.763682833,1127491.76809817,80.6902236938477,41,1.90682091944311,-0.769298279903134 +-146.13811,59.9042061,13.719616,437281.675760193,1127491.76561495,89.1532897949219,41,1.95013737346112,-0.611960555162817 +-146.07214,59.9002779,13.719616,440985.898936086,1127491.78645652,93.4027557373047,41,1.97035968976168,-0.538507330335491 +-146.00619,59.8963171,13.719616,444689.884013988,1127491.78636548,96.7123718261719,41,1.98548203429142,-0.483578658656595 +-145.94026,59.8923236,13.719616,448393.639370495,1127491.75307533,97.3841781616211,41,1.98848840353921,-0.472658667445424 +-145.87434,59.8882975,13.719616,452097.724296152,1127491.76461692,98.3203048706055,41,1.99264321653642,-0.457567200737865 +-145.80844,59.8842388,13.719616,455801.592202308,1127491.75289882,92.9527969360352,41,1.96826246216183,-0.546125059586483 +-145.74255,59.8801474,13.719616,459505.805090382,1127491.77490138,86.9532852172852,41,1.93928599490441,-0.65137585937259 +-145.67668,59.8760235,13.719616,463209.813600984,1127491.7836469,84.0117645263672,41,1.92434010643248,-0.705663592283932 +-145.61083,59.8718669,13.719616,466913.627521902,1127491.75586343,84.4944305419922,41,1.92682808333318,-0.696626550041295 +-145.54499,59.8676777,13.719616,470617.806068696,1127491.77244942,89.929817199707,41,1.95390371062419,-0.598280143566917 +-145.47917,59.863456,13.719616,474321.801201768,1127491.77370144,93.328987121582,41,1.97001655255402,-0.539753702614807 +-145.41337,59.8592018,13.719616,478025.619878905,1127491.75858661,95.7169189453125,41,1.98098871055794,-0.499899692978887 +-145.34758,59.8549149,13.719616,481729.825563079,1127491.7764501,100.477722167969,140,2.00206978103987,-0.423327227851949 +-145.28181,59.8505956,13.719616,485433.867274616,1127491.78813987,109.355964660645,140,2.03884247597501,-0.289758303875424 +-145.21606,59.8462437,13.719616,489137.754875598,1127491.77049888,139.505813598633,140,2.14459230625619,0.0943552637124736 +-145.15032,59.8418593,13.719616,492842.047457867,1127491.80786103,157.965072631836,140,2.19856107151071,0.290385223336109 +-145.08461,59.8374424,13.719616,496545.644751262,1127491.75141415,178.475372314453,140,2.25157829660594,0.482958917504611 +-145.01891,59.8329931,13.719616,500249.659387847,1127491.76028703,195.241592407227,140,2.29057234114209,0.624596417268291 +-144.95323,59.8285112,13.719616,503953.547696944,1127491.73719111,195.431564331055,140,2.29099470834759,0.626130575514273 +-144.88756,59.823997,13.719616,507657.865650182,1127491.79090823,179.800720214844,140,2.25479142702294,0.494629924297862 +-144.82192,59.8194502,13.719616,511361.517516224,1127491.73499366,129.22834777832,140,2.11135779178048,-0.026361978938171 +-144.75629,59.8148711,13.719616,515065.612795848,1127491.75525307,70.5693740844727,140,1.84861626547345,-0.980714196383156 +-144.69068,59.8102595,13.719616,518769.607855743,1127491.7522415,56.7000007629395,41,1.75358306473665,-1.32590190663525 +-144.62508,59.8056155,13.05374067,522474.061632638,1127491.81487234,29.0054912567139,41,1.46248022537242,-2.38327050822868 +-144.49396,59.7962304,13.719616,529881.603197204,1127491.75262227,61.2082824707031,40,1.78681019319039,-1.2052114921246 +-144.42842,59.7914892,13.719616,533585.813501488,1127491.77354407,78.4911041259766,40,1.89482043830035,-0.812887452691969 +-144.3629,59.7867158,13.719616,537289.953135403,1127491.80150508,85.3481369018555,40,1.93119404516868,-0.680768130485174 +-144.2974,59.78191,13.719616,540994.03214072,1127491.81361565,92.6745910644531,40,1.96696067833966,-0.550853509994714 +-144.23192,59.7770719,13.719616,544698.055725265,1127491.82020147,97.1594467163086,40,1.98748503300899,-0.47630319560165 +-144.16646,59.7722014,13.719616,548402.032348226,1127491.80947744,101.951881408691,40,2.00839524461022,-0.400351338697368 +-144.10102,59.7672987,13.719616,552105.965525707,1127491.80285753,109.544830322266,40,2.03959188700408,-0.287036229114646 +-144.0356,59.7623637,13.719616,555809.863696734,1127491.78858781,113.639099121094,141,2.05552778217613,-0.229152509292413 +-143.9702,59.7573964,13.719616,559513.733656779,1127491.7659926,116.125541687012,141,2.06492775284567,-0.195009132801893 +-143.90482,59.7523969,13.719616,563217.580503273,1127491.74546623,127.827827453613,141,2.10662540776604,-0.0435513484354858 +-143.83945,59.7473651,13.719616,566921.966297397,1127491.80067417,132.035202026367,141,2.12068973429405,0.0075342998726852 +-143.77411,59.7423011,13.719616,570625.788898258,1127491.77186645,141.984786987305,141,2.15224181423232,0.122140460068709 +-143.70879,59.7372049,13.719616,574329.608653322,1127491.7432352,158.689010620117,141,2.20054685244928,0.2975981465033 +-143.64348,59.7320765,13.719616,578033.985905268,1127491.8012196,205.875,240,2.31360361217781,0.708252567449254 +-143.5782,59.726916,13.719616,581737.818433642,1127491.78276149,294.778961181641,240,2.46949648404192,1.2744999743153 +-143.51294,59.7217232,13.719616,585441.670055949,1127491.75168257,299.560363769531,340,2.47648434929797,1.29988189546061 +-143.4477,59.7164984,13.719616,589145.542221255,1127491.74056165,312.449432373047,340,2.49477974002126,1.366335976592 +-143.38247,59.7112413,13.719616,592850.000528379,1127491.80500304,309.800170898438,340,2.49108165299784,1.35290346898381 +-143.31727,59.7059522,13.719616,596553.93914442,1127491.79962529,307.916015625,340,2.48843227843444,1.34328018436276 +-143.25209,59.700631,13.719616,600257.920119648,1127491.80159014,270.954681396484,240,2.43289665889924,1.14155896276694 +-143.18693,59.6952776,13.719616,603961.951939165,1127491.7993703,246.776596069336,240,2.39230396946207,0.99411472842407 +-143.12179,59.6898922,13.719616,607666.037655836,1127491.81455972,191.290863037109,141,2.28169422654935,0.592348571001253 +-143.05668,59.6844747,13.719616,611369.632130394,1127491.74360265,173.217895507812,141,2.23859275788233,0.435791734418679 +-142.99158,59.6790252,13.719616,615073.847382202,1127491.78064204,193.058578491211,141,2.28568910411403,0.606859106567754 +-142.92651,59.6735437,13.719616,618777.582824056,1127491.74056843,228.631301879883,241,2.35913568932729,0.873638067804864 +-142.86145,59.6680301,13.719616,622481.954144647,1127491.79772727,278.428253173828,241,2.44471330268751,1.18448038581186 +-142.79642,59.6624846,13.719616,626185.857023968,1127491.7868621,333.952209472656,341,2.52368432116086,1.47132566547985 +-142.73141,59.6569071,13.719616,629889.85352615,1127491.78973172,383.863830566406,341,2.58417719280131,1.69105304166254 +-142.66642,59.6512976,13.719616,633593.950250697,1127491.80596391,425.131195068359,341,2.62852297358388,1.85212957501085 +-142.60146,59.6456561,13.719616,637297.600188393,1127491.73923939,396.719207763672,241,2.5984832280109,1.74301664489275 +-142.53651,59.6399827,13.719616,641001.915214855,1127491.79160055,302.167999267578,141,2.48024846901229,1.31355425264975 +-142.47159,59.6342775,13.719616,644705.792743199,1127491.78124731,191.672012329102,141,2.28255870245339,0.595488594230738 +-142.40669,59.6285403,13.719616,648409.796775415,1127491.78179635,244.310974121094,240,2.38794297533689,0.978274353009765 +-142.34181,59.6227712,13.719616,652113.931932031,1127491.80396331,239.538375854492,240,2.37937510057618,0.947153386363918 +-142.27696,59.6169702,13.719616,655817.651145382,1127491.74871189,237.717437744141,240,2.37606104053461,0.93511577436603 +-142.21212,59.6111374,13.719616,659522.066178758,1127491.82372375,210.662841796875,240,2.32358793842859,0.744518490202511 +-142.14732,59.6052728,13.719616,663225.522714563,1127491.73081162,190.700729370117,141,2.28035235408854,0.587474507215072 +-142.08253,59.5993763,13.719616,666929.690047045,1127491.75665529,172.742446899414,141,2.2373990670933,0.431455908759672 +-142.01776,59.593448,13.719616,670634.019080627,1127491.81272248,164.278076171875,141,2.21557960827444,0.352201406435964 +-141.95302,59.587488,13.719616,674337.960671457,1127491.80825726,160.973419189453,141,2.20675416887416,0.32014489150295 +-141.88831,59.5814962,13.719616,678041.523287011,1127491.73038468,155.745010375977,141,2.19241414200285,0.2680578208552 +-141.82361,59.5754726,13.719616,681745.820600592,1127491.78255829,146.140426635742,141,2.16477037087069,0.167647753785356 +-141.75894,59.5694173,13.719616,685449.749816412,1127491.77084834,151.348739624023,141,2.17997880866484,0.222889140774021 +-141.69429,59.5633302,13.719616,689153.873021321,1127491.78620209,145.543365478516,141,2.1629924131294,0.161189703789344 +-141.62967,59.5572115,13.719616,692857.638919932,1127491.74612872,137.709762573242,141,2.13896472951908,0.0739142987329584 +-141.56507,59.5510611,13.719616,696561.609577439,1127491.7427189,140.05793762207,141,2.14630772699592,0.100586161468972 +-141.50049,59.544879,13.719616,700265.791400539,1127491.77585746,142.72688293457,141,2.1545057811774,0.130363834213761 +-141.43594,59.5386653,13.719616,703969.63508399,1127491.75042455,139.683258056641,141,2.14514435622632,0.0963604667747271 +-141.37141,59.5324199,13.719616,707673.702708431,1127491.76023479,144.748886108398,141,2.16061523036951,0.152555097489901 +-141.3069,59.5261429,13.719616,711377.998539694,1127491.81619574,151.48454284668,141,2.18036832063457,0.224303959425873 +-141.24242,59.5198343,13.719616,715081.975326649,1127491.81057026,186.345077514648,141,2.27031792493284,0.551026596410323 +-141.17797,59.5134941,13.719616,718785.639416093,1127491.74163785,229.657318115234,141,2.36108028892845,0.880701408600262 +-141.11354,59.5071224,13.719616,722489.548596638,1127491.72745506,268.052490234375,240,2.42821984621913,1.12457144421754 +-141.04913,59.5007191,13.719616,726193.711338618,1127491.75702796,278.753936767578,240,2.44522100952478,1.1863245219588 +-140.98475,59.4942843,13.719616,729897.578190942,1127491.73141466,293.759674072266,240,2.46799217766965,1.26903590419944 +-140.92039,59.487818,13.719616,733601.709049408,1127491.75941063,300.478820800781,240,2.4778138662439,1.30471108049013 +-140.85606,59.4813202,13.719616,737305.556597005,1127491.7300137,299.173217773438,240,2.47592271254196,1.29784187045568 +-140.79175,59.4747909,13.719616,741009.680718104,1127491.75316381,295.782104492188,240,2.47097189462572,1.27985908667977 +-140.72747,59.4682302,13.719616,744713.531864397,1127491.72773114,287.998168945312,240,2.4593897265805,1.23778934645964 +-140.66321,59.461638,13.719616,748417.672107341,1127491.75383676,275.779357910156,240,2.44056175610665,1.16940078366081 +-140.59898,59.4550144,13.719616,752121.551865879,1127491.7292598,252.143951416016,240,2.40164855449731,1.02805692848218 +-140.53477,59.4483594,13.719616,755825.730969484,1127491.76622216,228.04150390625,240,2.35801389646133,0.869563395924144 +-140.47059,59.441673,13.719616,759529.662034709,1127491.75045504,214.460586547852,240,2.33134748944585,0.772703394293558 +-140.40643,59.4349552,13.719616,763233.904879364,1127491.79532435,210.257797241211,142,2.32275211022996,0.741482523615974 +-140.3423,59.4282061,13.719616,766937.909825009,1127491.7964199,206.566131591797,142,2.31505911646456,0.713539374461013 +-140.2782,59.4214257,13.719616,770641.683042479,1127491.75220357,209.674789428711,142,2.32154621553834,0.737102369899381 +-140.21412,59.414614,13.719616,774345.784300289,1127491.77775027,197.166641235352,142,2.29483343822731,0.640073938120003 +-140.15007,59.4077709,13.719616,778049.668468898,1127491.74512774,184.454681396484,142,2.26588968194754,0.53494195394134 +-140.08604,59.4008966,13.719616,781753.89068565,1127491.79243445,189.411758422852,142,2.27740693591145,0.576775907689843 +-140.02204,59.3939911,13.719616,785457.903462568,1127491.80158278,188.215713500977,142,2.27465587839989,0.566783281577872 +-139.95807,59.3870543,13.719616,789161.715255848,1127491.76016587,187.126007080078,142,2.27213415065582,0.557623646638633 +-139.89412,59.3800863,13.719616,792865.883447231,1127491.79704706,176.920135498047,142,2.24777726331136,0.469152479655748 +-139.8302,59.3730871,13.719616,796569.860530858,1127491.79250718,171.838729858398,142,2.23512105395471,0.423181514830605 +-139.76631,59.3660567,13.719616,800273.652598424,1127491.74511301,172.452056884766,142,2.2366683786882,0.428801839913082 +-139.70244,59.3589952,13.719616,803977.816950581,1127491.78542873,151.46955871582,142,2.18032536016419,0.224147914735307 +-139.6386,59.3519025,13.719616,807681.808430972,1127491.78117588,137.992370605469,142,2.13985507556399,0.0771482896981339 +-139.57479,59.3447787,13.719616,811385.63070362,1127491.74188059,122.339691162109,142,2.08756737981749,-0.11277554564737 +-139.511,59.3376238,13.719616,815089.843408109,1127491.78889157,108.100479125977,142,2.03382761884976,-0.307973696337038 +-139.44724,59.3304378,13.719616,818793.898970834,1127491.79921853,93.6889038085938,142,1.97168815758938,-0.533681956002816 +-139.38351,59.3232208,13.719616,822497.800974691,1127491.78241431,45,40,1.65321251377534,-1.69047639633417 +-139.31981,59.3159727,13.719616,826201.55785744,1127491.72621854,27,40,1.43136376415899,-2.49629437687814 +-139.25613,59.3086936,13.719616,829905.726772363,1127491.76517133,16,40,1.20411998265592,-3.32170865313004 +-139.19248,59.3013835,12.96185313,833609.76009,1127491.77409829,11,40,1.04139268515823,-3.91278064463658 +-149.39168,60.0234129,12.25057369,255785.930968206,1123787.78885878,265.204650878906,33,2.42358113599719,1.10772232467175 +-149.12568,60.0139626,13.70742218,270602.031177918,1123787.7897732,186.579696655273,33,2.27086438265634,0.553011486836656 +-148.52777,59.9907659,9.274187291,303937.992590363,1123787.79113974,117.631393432617,33,2.07052324159619,-0.174684720548527 +-147.40089,59.9396625,13.57703899,366905.528915937,1123787.75384482,47.4582099914551,33,1.67631135365599,-1.60657481682236 +-147.33471,59.9363603,13.71844906,370609.787286191,1123787.77429672,85.9062118530273,33,1.93402456867353,-0.670486861203733 +-147.26855,59.9330253,13.719616,374313.672743871,1123787.76151076,99.4019165039062,140,1.99739475782837,-0.440308246540574 +-147.2024,59.9296575,13.719616,378017.746604567,1123787.77091346,170.868270874023,140,2.23266142454838,0.414247438778688 +-147.13626,59.9262569,13.719616,381722.016019239,1123787.80270126,210.115768432617,140,2.32245864586765,0.740416577289007 +-147.07014,59.9228234,13.719616,385425.935139033,1123787.7879295,193.576370239258,140,2.28685234211995,0.61108431902646 +-147.00403,59.9193572,13.719616,389130.062950852,1123787.80599686,161.242065429688,140,2.20747835261033,0.322775333535344 +-146.93794,59.9158582,13.719616,392833.853587949,1123787.78687725,151.412307739258,140,2.18016117877035,0.223551561050866 +-146.87186,59.9123264,13.719616,396537.868348935,1123787.78887407,71.5114517211914,41,1.8543755945435,-0.959794669324569 +-146.8058,59.9087618,13.719616,400241.560206355,1123787.75200453,65.788200378418,41,1.81814800653076,-1.09138360936994 +-146.73974,59.9051645,13.719616,403946.043392962,1123787.80766411,63.0012359619141,41,1.79934906955158,-1.15966671422914 +-146.67371,59.9015344,13.719616,407649.663749693,1123787.76257832,63.88623046875,41,1.80540726385733,-1.13766162332983 +-146.60769,59.8978716,13.719616,411353.535480064,1123787.74873299,66.2343902587891,41,1.82108354263521,-1.08072090435316 +-146.54168,59.8941761,13.719616,415057.665670522,1123787.76647897,69.4996719360352,41,1.84198275456557,-1.00480900139311 +-146.47568,59.8904478,13.719616,418762.062668212,1123787.8050732,65.5205078125,41,1.81637725473698,-1.09781548530784 +-146.40971,59.8866869,13.719616,422465.622712093,1123787.75989792,70.384895324707,41,1.84747946907168,-0.984843365388413 +-146.34374,59.8828932,13.719616,426170.017901195,1123787.79830282,71.4400863647461,41,1.85394197090443,-0.961369714150197 +-146.2778,59.8790669,13.719616,429873.590261636,1123787.75041282,73.4341659545898,41,1.86589816663583,-0.917941398615707 +-146.21186,59.8752079,13.719616,433578.010620662,1123787.7980701,79.026725769043,41,1.89777398864687,-0.802159314806196 +-146.14595,59.8713163,13.719616,437281.622239151,1123787.75697375,90.804573059082,41,1.95810772081529,-0.583009978608872 +-146.08005,59.867392,13.719616,440985.54179754,1123787.74594709,96.4603729248047,41,1.98434893661211,-0.48769439284613 +-146.01416,59.8634351,13.719616,444689.775010909,1123787.77658203,99.5277328491211,140,1.99794411135032,-0.43831283774776 +-145.94829,59.8594455,13.719616,448393.776090167,1123787.77076259,102.914428710938,140,2.0124762675734,-0.385527898455165 +-145.88244,59.8554234,13.719616,452097.549357087,1123787.74953878,103.267463684082,140,2.01396351059761,-0.380125807289812 +-145.8166,59.8513686,13.719616,455801.658700888,1123787.75820752,100.381935119629,41,2.00165556356835,-0.424831783937923 +-145.75078,59.8472813,13.719616,459505.554230179,1123787.75032974,96.2128601074219,41,1.98323312505667,-0.491747338899806 +-145.68497,59.8431613,13.719616,463209.799870264,1123787.77235753,94.08642578125,41,1.97352697057347,-0.527002862395102 +-145.61918,59.8390089,13.719616,466913.844270291,1123787.78785907,97.0832595825195,140,1.98714434939595,-0.477540655724962 +-145.55341,59.8348238,13.719616,470617.698615741,1123787.76248042,100.848518371582,140,2.00366952210483,-0.417516511692448 +-145.48765,59.8306062,13.719616,474321.92123381,1123787.78877968,104.21036529541,140,2.01791091826021,-0.365787695956937 +-145.42191,59.8263561,13.719616,478025.964918057,1123787.79541237,104.595352172852,140,2.01951238653383,-0.359970706082602 +-145.35619,59.8220735,13.719616,481729.836619246,1123787.78135749,108.575119018555,140,2.03573031410218,-0.301062564096984 +-145.29049,59.8177584,13.719616,485433.543283998,1123787.74561103,120.76993560791,140,2.0819588347435,-0.133147382194252 +-145.2248,59.8134108,13.719616,489137.646016081,1123787.76083889,145.706558227539,140,2.16347909973109,0.162957488440846 +-145.15913,59.8090307,13.719616,492841.597592479,1123787.75353321,166.184387207031,140,2.22059021999963,0.37040137839282 +-145.09347,59.8046181,13.719616,496545.959108547,1123787.79750908,182.008514404297,140,2.2600917048659,0.513882046273416 +-145.02784,59.8001731,13.719616,500249.627665302,1123787.75393146,186.519470214844,140,2.27072417322521,0.552502206163046 +-144.96222,59.7956956,13.719616,503953.719995175,1123787.76089142,176.847549438477,140,2.24759904621059,0.468505144277545 +-144.89662,59.7911858,13.719616,507657.685801917,1123787.76487313,155.943801879883,140,2.19296811802963,0.270070019904947 +-144.83104,59.7866435,13.719616,511361.535014874,1123787.74282835,90.6511535644531,140,1.95737333500063,-0.585677477502296 +-144.76547,59.7820688,13.719616,515065.827157923,1123787.7825195,61.8838500976562,41,1.79157732545642,-1.18789590705939 +-144.69992,59.7774617,13.719616,518770.014945145,1123787.80664722,51.0918502807617,41,1.70835163085165,-1.49019538484213 +-144.6344,59.7728223,13.719616,522473.549514407,1123787.74676948,36.4076957702637,41,1.56119319346494,-2.02471683263045 +-144.56889,59.7681504,13.719616,526177.549187544,1123787.73670465,63.8155059814453,41,1.80492621702796,-1.13940892271854 +-144.50339,59.7634463,13.719616,529882.016078447,1123787.81052845,97.3527145385742,41,1.98834806569362,-0.473168414557002 +-144.43792,59.7587098,13.719616,533585.851865786,1123787.78628752,102.702522277832,141,2.01158110959429,-0.388779367738837 +-144.37247,59.753941,13.719616,537289.615948487,1123787.75350287,107.751037597656,141,2.03242146092805,-0.31308126326612 +-144.30703,59.7491398,13.719616,540993.870930063,1123787.78180899,109.580841064453,141,2.03973462944647,-0.286517747821136 +-144.24161,59.7443064,13.719616,544698.066218692,1123787.81224233,111.82551574707,141,2.04854090984572,-0.254530823848354 +-144.17622,59.7394407,13.719616,548401.656075281,1123787.75043026,113.886840820312,141,2.05647354594668,-0.225717225329917 +-144.11084,59.7345428,13.719616,552105.753965493,1123787.77131368,117.343452453613,141,2.06945886178636,-0.178550851822053 +-144.04548,59.7296126,13.719616,555809.814162793,1123787.78111366,122.070259094238,141,2.08660986636437,-0.116253507810657 +-143.98014,59.7246501,13.719616,559513.843460014,1123787.77914882,118.684509277344,141,2.07439403846267,-0.16062488149403 +-143.91482,59.7196555,13.719616,563217.845261984,1123787.78686173,128.770172119141,141,2.10981527618941,-0.0319648358427009 +-143.84952,59.7146286,13.719616,566921.82969197,1123787.78148918,136.634201049805,141,2.13555942165938,0.0615452486149073 +-143.78424,59.7095695,13.719616,570625.801815284,1123787.77344896,144.854995727539,141,2.16093347765155,0.1537110624551 +-143.71898,59.7044783,13.719616,574329.766649042,1123787.77316824,150.019546508789,141,2.17614784830807,0.208973999293301 +-143.65374,59.6993549,13.719616,578033.732632342,1123787.76898943,162.203628540039,141,2.2100605652715,0.332154666957588 +-143.58852,59.6941993,13.719616,581737.706496969,1123787.76032318,241.791793823242,240,2.38344155724535,0.961923917668637 +-143.52332,59.6890116,13.719616,585441.693213088,1123787.75763972,282.017242431641,240,2.45027566173779,1.2046844615378 +-143.45814,59.6837918,13.719616,589145.699470279,1123787.76037658,297.264373779297,340,2.47314286346603,1.28774466516397 +-143.39298,59.6785399,13.719616,592849.731953247,1123787.76798723,300.939758300781,340,2.47847956783312,1.30712909867234 +-143.32784,59.6732559,13.719616,596553.797341816,1123787.77994106,297.801666259766,340,2.47392712338727,1.29059332104798 +-143.26272,59.6679398,13.719616,600257.902310889,1123787.7957234,256.386413574219,240,2.40889500732852,1.05437811350867 +-143.19762,59.6625916,13.719616,603962.053530427,1123787.81483545,243.836059570312,240,2.38709793144799,0.975204912405723 +-143.13255,59.6572114,13.719616,607665.701682424,1123787.7563264,232.641723632812,240,2.36668760686054,0.901068787817481 +-143.06749,59.6517992,13.719616,611369.961717033,1123787.80216739,198.998794555664,141,2.29885044565891,0.654664855679637 +-143.00246,59.646355,13.719616,615073.731934247,1123787.76834246,237.876739501953,241,2.37635197713675,0.936172539146576 +-142.93745,59.6408787,13.719616,618777.574967,1123787.7348838,306.428649902344,241,2.48632936772563,1.33564181243786 +-142.87245,59.6353705,13.719616,622482.047891685,1123787.81715429,374.310974121094,341,2.57323256003018,1.6512990115286 +-142.80748,59.6298303,13.719616,626186.050836433,1123787.81680937,433.182006835938,341,2.63667040895477,1.88172338578749 +-142.74254,59.6242582,13.719616,629889.588517121,1123787.74280356,485.035247802734,341,2.68577330018988,2.06007910211392 +-142.67761,59.6186541,13.719616,633593.777718396,1123787.77286926,511.377899169922,341,2.70874195467202,2.14350781109974 +-142.61271,59.6130181,13.719616,637297.514801729,1123787.72740961,461.159942626953,341,2.66385157648127,1.98045314452135 +-142.54782,59.6073502,13.719616,641001.914644267,1123787.79743895,181.116348266602,141,2.25795765319384,0.506130561481512 +-142.48296,59.6016504,13.719616,644705.875472794,1123787.79013675,229.778549194336,141,2.36130948300605,0.881533906908588 +-142.41812,59.5959187,13.719616,648409.95799277,1123787.80114336,265.749237060547,240,2.42447202638115,1.11095829283171 +-142.35331,59.5901552,13.719616,652113.612630848,1123787.74296892,252.983047485352,240,2.40309141987052,1.03329782735246 +-142.28851,59.5843598,13.719616,655817.956172771,1123787.80013705,237.365036010742,240,2.37541674753391,0.932775518287955 +-142.22374,59.5785327,13.719616,659521.882879456,1123787.79743996,207.170776367188,141,2.31632849355594,0.718150114373181 +-142.15899,59.5726737,13.719616,663225.957337243,1123787.81078947,185.455856323242,141,2.26824055202813,0.543480985079164 +-142.09427,59.5667829,13.719616,666929.629908702,1123787.75051819,174.312118530273,141,2.24132758118845,0.445725393262793 +-142.02956,59.5608603,13.719616,670634.015396655,1123787.81668121,171.259674072266,141,2.23365511317198,0.417856799486568 +-141.96488,59.554906,13.719616,674338.009938083,1123787.81864946,167.824127197266,141,2.22485439722805,0.3858900872038 +-141.90023,59.5489199,13.719616,678041.621996375,1123787.74354115,159.960494995117,141,2.20401273938068,0.310187237100778 +-141.83559,59.5429021,13.719616,681745.964321477,1123787.80579797,157.505828857422,141,2.19729663046703,0.285792412558062 +-141.77098,59.5368526,13.719616,685449.935017377,1123787.80048497,162.34928894043,141,2.21045039083745,0.333570624680413 +-141.7064,59.5307714,13.719616,689153.540505207,1123787.72576222,155.925674438477,141,2.1929176312178,0.269886637394023 +-141.64183,59.5246586,13.719616,692857.893454451,1123787.79945076,152.150146484375,141,2.1822723748166,0.23122002768618 +-141.57729,59.518514,13.719616,696561.896079564,1123787.79133486,155.627090454102,141,2.19208519812067,0.266863002785184 +-141.51278,59.5123379,13.719616,700265.548546919,1123787.73257916,153.866577148438,141,2.18714429275935,0.248916224238092 +-141.44828,59.5061301,13.719616,703969.969715792,1123787.81142992,151.154937744141,141,2.17942233874511,0.220867883193249 +-141.38381,59.4998907,13.719616,707674.055545781,1123787.82732929,158.888778686523,141,2.20109322680709,0.299582734121637 +-141.31937,59.4936197,13.719616,711377.812392951,1123787.77852043,168.525543212891,141,2.2266657356861,0.39246938549093 +-141.25495,59.4873172,13.719616,715081.798636352,1123787.7819126,216.288665771484,141,2.33503376159409,0.786092986902806 +-141.19055,59.4809831,13.719616,718786.022732304,1123787.82647121,272.694427490234,240,2.43567626322594,1.15165527905958 +-141.12618,59.4746174,13.719616,722489.936858784,1123787.80336611,296.19384765625,340,2.4715760333996,1.28205349114488 +-141.06184,59.4682202,13.719616,726193.545184784,1123787.72186916,301.244659423828,240,2.47891935631879,1.3087265359804 +-140.99751,59.4617916,13.719616,729897.960153737,1123787.81107039,304.795623779297,240,2.48400872716183,1.3272125835334 +-140.93322,59.4553314,13.719616,733601.529911996,1123787.71931183,270.825897216797,240,2.43269019059138,1.14080901094088 +-140.86894,59.4488398,13.719616,737305.918867094,1123787.79825744,265.947174072266,142,2.42479537991194,1.11213280514984 +-140.80469,59.4423168,13.719616,741010.024943631,1123787.82644227,243.918533325195,142,2.38724479996552,0.975738380781845 +-140.74047,59.4357623,13.719616,744713.856600716,1123787.7912687,212.659820556641,142,2.32768544308145,0.759401796645962 +-140.67627,59.4291764,13.719616,748417.972038917,1123787.81477095,196.792831420898,142,2.29400927432373,0.637080339582393 +-140.6121,59.4225591,13.719616,752121.823326913,1123787.78375996,181.068878173828,142,2.2578438108946,0.505717053756832 +-140.54795,59.4159104,13.719616,755825.97085017,1123787.81045055,163.161758422852,142,2.21261837713799,0.341445369728853 +-140.48383,59.4092304,13.719616,759529.864405835,1123787.79151712,150.770156860352,142,2.17831538666972,0.216847117299871 +-140.41973,59.402519,13.719616,763234.066606558,1123787.82936368,144.692855834961,142,2.16044708849257,0.151944358200389 +-140.35566,59.3957763,13.719616,766938.027216699,1123787.81957307,135.586395263672,142,2.13221611461709,0.0494014031624551 +-140.29162,59.3890024,13.719616,770641.750113836,1123787.77154368,156.05451965332,142,2.19327635122675,0.271189610855396 +-140.2276,59.3821971,13.719616,774345.800195229,1123787.77845361,157.417663574219,142,2.1970534622188,0.284909156073353 +-140.16361,59.3753606,13.719616,778049.624863281,1123787.7451873,165.06982421875,142,2.21766768881056,0.359785910940668 +-140.09964,59.3684928,13.719616,781753.786722414,1123787.77701228,172.478225708008,142,2.23673427592092,0.429041197471299 +-140.0357,59.3615938,13.719616,785457.735423187,1123787.76677505,169.500534057617,142,2.22917107090436,0.401569478097488 +-139.97178,59.3546636,13.719616,789162.031234972,1123787.8318234,164.699111938477,142,2.21669125744991,0.35623923353753 +-139.9079,59.3477022,13.719616,792865.57193732,1123787.73358705,175.833053588867,142,2.24510051830272,0.459429777765309 +-139.84403,59.3407096,13.719616,796570.026110262,1123787.82877448,179.148391723633,142,2.25321291370957,0.488896313391156 +-139.7802,59.3336859,13.719616,800273.734984339,1123787.76870768,184.450729370117,142,2.26588037688888,0.534908155312357 +-139.71639,59.326631,13.719616,803977.815321053,1123787.78147819,169.666091918945,142,2.22959505643721,0.403109514570347 +-139.65261,59.319545,13.719616,807681.716640508,1123787.75664836,161.117126464844,142,2.20714170760632,0.321552542792747 +-139.58885,59.312428,13.719616,811385.996737432,1123787.82590654,152.804077148438,142,2.18413494232505,0.237985404506554 +-139.52513,59.3052798,13.719616,815089.558127754,1123787.72222579,135.151138305664,142,2.13081970788,0.0443292553192028 +-139.46142,59.2981006,13.719616,818794.064499009,1123787.8342636,117.489311218262,142,2.069998357756,-0.176591248472847 +-139.39775,59.2908904,13.719616,822497.859358374,1123787.79244507,99.9798965454102,142,1.99991268302889,-0.431162423524901 +-139.3341,59.2836491,13.719616,826202.059462429,1123787.83164328,69.6949081420898,40,1.84320105002668,-1.0003838045422 +-139.27049,59.2763769,13.719616,829905.557579853,1123787.72407593,40,40,1.60205999132796,-1.87627695824656 +-139.20689,59.2690737,13.719616,833610.024605842,1123787.83239428,32,40,1.50514997831991,-2.2282817863634 +-139.14333,59.2617395,13.719616,837313.804023129,1123787.78038427,32,40,1.50514997831991,-2.2282817863634 +-139.07979,59.2543744,13.719616,841018.007623971,1123787.82924279,25,40,1.39794000867204,-2.61769899689636 +-139.01629,59.2469783,13.719616,844721.53550996,1123787.71405453,20,40,1.30102999566398,-2.9697038250132 +-138.9528,59.2395514,13.17552437,848426.051089869,1123787.83691725,11,40,1.04139268515823,-3.91278064463658 +-149.32985,59.9880616,9.631301479,259489.987870141,1120083.78909201,119.276382446289,33,2.0765544588534,-0.152777617989553 +-149.19699,59.9833412,9.730171114,266897.60659516,1120083.76640835,80.940185546875,33,1.90816419563118,-0.764419117378873 +-149.13057,59.9809314,9.786530381,270601.65888093,1120083.76855152,73.0637817382812,33,1.86370214728409,-0.925917967707578 +-148.53325,59.9577576,11.27718014,303937.836504709,1120083.77605954,130.125595092773,33,2.11436272864668,-0.0154471905457719 +-147.40748,59.9067047,13.62967198,366905.612439134,1120083.76215789,48.6218490600586,33,1.68683147078273,-1.56836274867768 +-147.34137,59.9034058,13.719616,370609.605126277,1120083.76092319,59.4584999084473,33,1.77421394809627,-1.25096464963275 +-147.27527,59.9000741,13.719616,374313.777403016,1120083.77854012,55.648136138916,140,1.74545062279221,-1.3554412570075 +-147.20919,59.8967096,13.719616,378017.581701344,1120083.75826255,149.212814331055,140,2.17380612175791,0.200468180067799 +-147.14312,59.8933123,13.719616,381721.579887994,1120083.7560883,223.530212402344,140,2.34933623079171,0.838043637359685 +-147.07706,59.8898822,13.719616,385425.779107309,1120083.77222741,198.936050415039,140,2.29871349140815,0.654167398750262 +-147.01102,59.8864194,13.719616,389129.630606491,1120083.75943465,170.065368652344,140,2.23061588483865,0.406817454697794 +-146.94499,59.8829238,13.719616,392833.697394717,1120083.76431026,147.452743530273,140,2.16865285751836,0.181750053461727 +-146.87897,59.8793955,13.719616,396537.985409242,1120083.79823591,79.179817199707,41,1.89861449477347,-0.799106356650065 +-146.81297,59.8758344,13.719616,400241.948236385,1120083.79010328,67.9904937744141,41,1.83244819520742,-1.03944124241609 +-146.74699,59.8722406,13.719616,403945.591784322,1120083.74965344,66.4145202636719,41,1.82226303992506,-1.07643663353438 +-146.68101,59.8686141,13.719616,407650.032581546,1120083.79829046,72.5351104736328,41,1.86054827683181,-0.937373725394487 +-146.61506,59.8649549,13.719616,411353.613557839,1120083.75219497,71.3829498291016,41,1.85359449077614,-0.962631861156827 +-146.54911,59.861263,13.719616,415058.005953582,1120083.79586193,70.3846435546875,41,1.84747791557749,-0.984849008122712 +-146.48319,59.8575385,13.719616,418761.55142829,1120083.75327181,72.4330825805664,41,1.85993696813931,-0.939594173050516 +-146.41727,59.8537812,13.719616,422465.923730169,1120083.79007656,69.9809722900391,41,1.84497997211753,-0.993922251753337 +-146.35137,59.8499913,13.719616,426170.01795635,1120083.80222664,67.2169570922852,41,1.82747884809267,-1.05749132952973 +-146.28549,59.8461687,13.719616,429873.842438532,1120083.77735328,64.8333053588867,41,1.81179816355157,-1.11444805149598 +-146.21962,59.8423135,13.719616,433577.957653492,1120083.7906098,68.889274597168,41,1.83815161166308,-1.018724805932 +-146.15377,59.8384257,13.719616,437281.815910284,1120083.77659804,81.8639755249023,41,1.91309283127681,-0.746516905941278 +-146.08793,59.8345053,13.719616,440985.978952238,1120083.80051107,90.5386505126953,41,1.9568340170064,-0.587636434394012 +-146.02211,59.8305522,13.719616,444689.900420981,1120083.7847673,95.6090774536133,140,1.98049912764075,-0.501677997874977 +-145.95631,59.8265666,13.719616,448393.584663825,1120083.7503977,99.6960601806641,140,1.99867799606887,-0.43564715897842 +-145.89052,59.8225484,13.719616,452097.594741732,1120083.75321633,103.456230163574,140,2.01475664912636,-0.377244901769146 +-145.82474,59.8184976,13.719616,455801.937663567,1120083.79375561,106.115043640137,140,2.02577695700943,-0.337215998028795 +-145.75898,59.8144143,13.719616,459506.064331096,1120083.81447079,104.237297058105,140,2.01802314130805,-0.365380069815556 +-145.69324,59.8102984,13.719616,463209.983107454,1120083.80315557,105.814086914062,140,2.02454348869911,-0.341696306998792 +-145.62752,59.8061499,13.719616,466913.700989614,1120083.7587204,107.87873840332,140,2.03293585891841,-0.311212822941331 +-145.56181,59.801969,13.719616,470617.776855424,1120083.77314243,112.968635559082,140,2.05295788335637,-0.238487115327934 +-145.49612,59.7977556,13.719616,474321.664336964,1120083.76451747,113.808738708496,140,2.05617561027672,-0.226799412722524 +-145.43044,59.7935096,13.719616,478025.926544199,1120083.79269265,110.118041992188,140,2.04185848060407,-0.278803314209239 +-145.36478,59.7892312,13.719616,481730.012838892,1120083.8079587,116.355178833008,140,2.0657857179927,-0.191892758500248 +-145.29914,59.7849203,13.719616,485433.9315928,1120083.79821525,125.108085632324,140,2.09728537869442,-0.0774769999333399 +-145.23352,59.7805769,13.719616,489137.689745488,1120083.76247009,148.023422241211,140,2.17033044070092,0.18784351441069 +-145.16791,59.7762011,13.719616,492841.847468537,1120083.78504261,179.569549560547,140,2.25423269324983,0.492600443755446 +-145.10232,59.7717928,13.719616,496545.858435021,1120083.78079198,180.844131469727,140,2.25730442013846,0.503757832573085 +-145.03675,59.7673522,13.719616,500249.726562459,1120083.77093837,171.668426513672,140,2.2346904264842,0.421617352944416 +-144.97119,59.7628791,13.719616,503954.016458219,1120083.80827278,153.540588378906,140,2.18622320052264,0.245570554328438 +-144.90566,59.7583736,13.719616,507657.624076055,1120083.75175453,126.423156738281,140,2.10182663029565,-0.0609818779153913 +-144.84014,59.7538357,13.719616,511361.665735297,1120083.75281323,75.0890502929688,41,1.87557661151751,-0.882786524302272 +-144.77464,59.7492655,13.719616,515065.592045434,1120083.74576017,64.309211730957,41,1.80827318625834,-1.12725177515367 +-144.70915,59.7446629,13.719616,518769.966124655,1120083.79676945,59.7390213012695,41,1.77625810332101,-1.2435396943965 +-144.64369,59.740028,13.719616,522473.683832843,1120083.76039424,37.905330657959,41,1.57870028945471,-1.96112606297295 +-144.57824,59.7353607,13.719616,526177.863020255,1120083.78151755,109.099006652832,41,2.03782079635225,-0.293469335881676 +-144.51281,59.7306612,13.719616,529881.952643069,1120083.80334838,123.880264282227,140,2.09300212319581,-0.0930350064671088 +-144.4474,59.7259293,13.719616,533585.962696658,1120083.80294635,126.867408752441,141,2.10335006955831,-0.0554483116805769 +-144.38201,59.7211651,13.719616,537289.898417524,1120083.79059658,124.841865539551,141,2.09636024980008,-0.0808373321356364 +-144.31664,59.7163687,13.719616,540993.764994078,1120083.77659426,125.563842773438,141,2.09886459844057,-0.0717408230611258 +-144.25129,59.7115399,13.719616,544697.572473525,1120083.7380578,135.556869506836,141,2.13212153086757,0.0490578479873357 +-144.18595,59.706679,13.719616,548401.877472071,1120083.79001476,133.164321899414,141,2.12438788190824,0.0209670275638441 +-144.12064,59.7017858,13.719616,552105.580600599,1120083.74502182,125.874160766602,141,2.09993658802524,-0.0678470509133119 +-144.05534,59.6968604,13.719616,555809.796423757,1120083.77914443,120.600006103516,141,2.08134732978359,-0.135368542749509 +-143.99006,59.6919028,13.719616,559513.976980091,1120083.80911369,120.237442016602,141,2.0800397283083,-0.140118124534414 +-143.92481,59.6869129,13.719616,563217.575993476,1120083.73839201,131.065505981445,141,2.11748840844792,-0.00409382934980855 +-143.85957,59.6818909,13.719616,566921.706281114,1120083.75748722,140.950180053711,141,2.14906563498792,0.110603670481244 +-143.79435,59.6768368,13.719616,570625.819834927,1120083.78150071,144.699371337891,141,2.16046664428367,0.152015390415427 +-143.72915,59.6717505,13.719616,574329.925083687,1120083.79875113,141.839263916016,141,2.15179646879956,0.120522838342685 +-143.66397,59.666632,13.719616,578034.028761413,1120083.80862719,143.850997924805,141,2.15791287902949,0.142739386095094 +-143.59882,59.6614815,13.719616,581737.579389904,1120083.74502797,154.488906860352,141,2.18889730018609,0.255283647570148 +-143.53368,59.6562988,13.719616,585441.696576681,1120083.75991187,215.282150268555,240,2.33300802257205,0.778734924571268 +-143.46856,59.651084,13.719616,589145.83055643,1120083.77671883,252.404281616211,240,2.40209671771363,1.02968478520235 +-143.40346,59.6458372,13.719616,592849.986234698,1120083.80593655,284.808471679688,340,2.45455290332514,1.22022062382939 +-143.33839,59.6405583,13.719616,596553.617324842,1120083.74615727,273.628753662109,240,2.43716173230485,1.15705092674926 +-143.27333,59.6352474,13.719616,600257.838139065,1120083.78699417,253.128326416016,240,2.40334074775727,1.0342034574024 +-143.2083,59.6299044,13.719616,603961.547683494,1120083.73668949,252.394332885742,241,2.4020795992881,1.02962260619474 +-143.14328,59.6245294,13.719616,607665.860238853,1120083.78711541,255.73860168457,241,2.40779628623245,1.05038724488154 +-143.07829,59.6191224,13.719616,611369.672992252,1120083.75534963,245.057220458984,241,2.38926750325467,0.983085416465049 +-143.01332,59.6136834,13.719616,615073.547282913,1120083.73187216,298.2109375,241,2.47452356805321,1.29275977831694 +-142.94836,59.6082125,13.719616,618778.042592775,1120083.82043726,428.67236328125,341,2.63212548523364,1.86521492558197 +-142.88343,59.6027096,13.719616,622482.057924605,1120083.823792,494.244781494141,341,2.69394209249201,2.08975048736068 +-142.81853,59.5971747,13.719616,626185.599883471,1120083.73984719,543.626220703125,440,2.73530039587511,2.23997565008319 +-142.75364,59.591608,13.719616,629889.780738253,1120083.77826758,590.274169921875,440,2.77105377914558,2.36984214315309 +-142.68877,59.5860093,13.719616,633594.05609085,1120083.82288523,572.086486816406,440,2.757461689471,2.32047179388639 +-142.62393,59.5803787,13.719616,637297.875905869,1120083.7883865,535.211791992188,341,2.72852567340835,2.21536792438559 +-142.55911,59.5747163,13.719616,641001.799537777,1120083.78027553,153.079574584961,141,2.18491724663019,0.240826957034732 +-142.49431,59.569022,13.719616,644705.83542903,1120083.78718814,573.6962890625,240,2.7586820406705,2.32490445776588 +-142.42953,59.5632958,13.719616,648409.990121545,1120083.80879576,442.237213134766,241,2.64565528455452,1.91435901850461 +-142.36478,59.5575378,13.719616,652113.713483925,1120083.75760226,301.889221191406,241,2.47984760702554,1.31209820749646 +-142.30005,59.551748,13.719616,655817.566734445,1120083.73038212,190.828796386719,241,2.28064391108195,0.588533525433777 +-142.23534,59.5459265,13.719616,659521.554396606,1120083.73785373,191.327423095703,141,2.28177722222587,0.592650034987705 +-142.17065,59.5400731,13.719616,663225.686889402,1120083.75772849,186.025604248047,141,2.26957272388647,0.548319813508367 +-142.10598,59.534188,13.719616,666929.966744544,1120083.81176007,178.594909667969,141,2.25186907641918,0.484015112783088 +-142.04134,59.5282711,13.719616,670633.847691605,1120083.78771669,177.545379638672,141,2.24930937489988,0.474717546253454 +-141.97672,59.5223225,13.719616,674337.888909022,1120083.79623648,172.785568237305,141,2.23750746559285,0.431849643050023 +-141.91213,59.5163422,13.719616,678041.542113051,1120083.73500326,168.398345947266,141,2.22633782143024,0.391278307317582 +-141.84755,59.5103301,13.719616,681745.925206359,1120083.79645644,166.718048095703,141,2.22198261700914,0.375458961761046 +-141.783,59.5042864,13.719616,685449.931116662,1120083.79764632,168.671249389648,141,2.22704106186875,0.393832677315051 +-141.71848,59.4982111,13.719616,689153.566230983,1120083.73672028,164.045959472656,141,2.2149655379812,0.349970927857801 +-141.65397,59.4921041,13.719616,692857.948435734,1120083.80950907,163.363571166992,141,2.21315521862853,0.343395331252317 +-141.58949,59.4859654,13.719616,696561.974701009,1120083.80776952,166.502563476562,141,2.22142092429973,0.373418733517403 +-141.52504,59.4797952,13.719616,700265.647253365,1120083.75166934,163.528686523438,141,2.2135939484705,0.344988923264343 +-141.46061,59.4735933,13.719616,703969.53134244,1120083.72344566,162.890670776367,141,2.21189621170958,0.338822258766334 +-141.3962,59.4673599,13.719616,707673.629141148,1120083.74496077,177.258453369141,141,2.24860695564089,0.472166159014371 +-141.33181,59.4610949,13.719616,711377.949091648,1120083.80513948,203.611709594727,141,2.30880275041395,0.690814467220533 +-141.26745,59.4547984,13.719616,715081.940692838,1120083.80720741,260.238006591797,141,2.41537072361572,1.07789976341723 +-141.20312,59.4484703,13.719616,718785.612397025,1120083.73844965,329.654052734375,340,2.51805841928602,1.45089078407817 +-141.13881,59.4421108,13.719616,722489.520956849,1120083.72788172,308.169891357422,340,2.48879020525819,1.3445802767491 +-141.07452,59.4357197,13.719616,726193.676965268,1120083.75351883,304.137359619141,240,2.4830697712782,1.32380202775936 +-141.01026,59.4292972,13.719616,729897.527683124,1120083.72737378,285.940795898438,142,2.45627612167355,1.22647984472629 +-140.94602,59.4228432,13.719616,733601.63626988,1120083.74725575,170.492324829102,142,2.23170483283352,0.410772824631883 +-140.8818,59.4163578,13.719616,737306.006814118,1120083.82413393,191.122192382812,142,2.28131111860817,0.590957013609008 +-140.81762,59.4098409,13.719616,741009.53832805,1120083.72390152,150.626571655273,142,2.17790159142203,0.215344094851305 +-140.75345,59.4032927,13.719616,744713.896809285,1120083.80157625,149.7431640625,142,2.17534700550076,0.206065109633845 +-140.68931,59.396713,13.719616,748417.98347405,1120083.81156292,146.347518920898,142,2.16538536409064,0.16988158469676 +-140.6252,59.390102,13.719616,752121.800109062,1120083.77416137,145.505020141602,142,2.16287797739193,0.160774040527619 +-140.56111,59.3834597,13.719616,755825.90762407,1120083.80157276,138.159942626953,142,2.14038214421196,0.0790627534679272 +-140.49705,59.376786,13.719616,759529.759742751,1120083.76855671,136.128326416016,142,2.13394850526315,0.055693940462466 +-140.43301,59.370081,13.719616,763233.915126679,1120083.79941331,138.656860351562,142,2.14194136211525,0.084726277937777 +-140.369,59.3633447,13.719616,766937.825230175,1120083.7787657,132.702896118164,142,2.12288040104388,0.015491426786633 +-140.30501,59.3565772,13.719616,770642.048650426,1120083.83204655,139.657974243164,142,2.1450657382535,0.0960749038576388 +-140.24105,59.3497784,13.719616,774346.039098357,1120083.83184324,136.282302856445,142,2.13443946353245,0.0574772410300052 +-140.17712,59.3429483,13.719616,778049.802729762,1120083.77663131,148.353088378906,142,2.17129659178502,0.191352850915112 +-140.11321,59.336087,13.719616,781753.898092609,1120083.793552,151.74284362793,142,2.18110821838857,0.226991479256235 +-140.04933,59.3291946,13.719616,785457.774248841,1120083.77543805,154.948760986328,142,2.19018810784892,0.259972229434735 +-139.98547,59.3222709,13.719616,789161.99667638,1120083.81775776,155.712188720703,142,2.19232260927305,0.267725347854515 +-139.92164,59.3153161,13.719616,792866.012083364,1120083.82318881,163.786224365234,142,2.21427737157733,0.347471311056703 +-139.85784,59.3083301,13.719616,796569.828895865,1120083.77933449,179.380889892578,142,2.25377617418037,0.490942236191645 +-139.79406,59.3013131,13.719616,800274.003174666,1120083.82710151,171.886383056641,142,2.23524147297791,0.423618911093898 +-139.73031,59.2942649,13.719616,803977.990988312,1120083.82380723,171.123443603516,142,2.23330951117869,0.416601474402337 +-139.66659,59.2871856,13.719616,807681.79601904,1120083.77895227,170.775390625,142,2.23242528739632,0.413389721242162 +-139.60289,59.2800752,13.719616,811385.979025045,1120083.81329912,165.903045654297,142,2.21985435889183,0.367728520813644 +-139.53922,59.2729338,13.719616,815089.988905117,1120083.81530314,159.68473815918,142,2.20326341050302,0.30746546073735 +-139.47558,59.2657614,13.719616,818793.831654961,1120083.78357062,152.108917236328,142,2.18215467488805,0.230792507950804 +-139.41197,59.258558,13.719616,822497.513264231,1120083.71672136,112.131050109863,142,2.04972588934929,-0.250226640064575 +-139.34838,59.2513235,13.719616,826201.5968822,1120083.72688648,83.5056457519531,40,1.92171583878937,-0.715195681404282 +-139.28482,59.2440581,13.719616,829905.528884464,1120083.71124196,69.5581817626953,40,1.84234822110599,-1.00348152260375 +-139.22128,59.2367618,13.719616,833609.869930146,1120083.79396339,59.3672866821289,40,1.77354720041828,-1.25338646750794 +-139.15778,59.2294345,13.719616,837313.518993086,1120083.71232714,44,40,1.64345267648619,-1.72592691110329 +-139.0943,59.2220763,13.719616,841017.588982119,1120083.72752285,47,40,1.67209785793572,-1.62187943592981 +-139.03085,59.2146872,13.719616,844721.531099917,1120083.71272055,46,40,1.66275783168157,-1.65580507719377 +-138.96742,59.2072673,13.719616,848425.903471913,1120083.8052748,42,40,1.6232492903979,-1.79931137599645 +-138.90403,59.1998165,13.719616,852129.605057754,1120083.73805531,36,40,1.55630250076729,-2.04248122445101 +-138.84066,59.1923348,13.719616,855833.751198658,1120083.76585948,23,40,1.36172783601759,-2.74923194396041 +-149.40091,59.9573312,13.66108704,255785.814364455,1116379.78119398,208.199768066406,33,2.31848024137271,0.725965876613683 +-149.33453,59.9550228,12.89903231,259489.734071388,1116379.77011006,190.34423828125,33,2.27953973525844,0.584522843679658 +-149.20179,59.950307,11.8408729,266898.025034649,1116379.78725989,184.613876342773,33,2.26626434128688,0.536302823600267 +-149.13544,59.9478996,13.71361198,270601.855611071,1116379.77515762,147.468185424805,33,2.16869833634969,0.181915245558053 +-149.0691,59.9454592,11.93146637,274305.671070175,1116379.76185537,47.5292625427246,33,1.67696107589564,-1.60421484019876 +-149.00276,59.9429858,11.39547102,278010.0339811,1116379.78890809,47.1135292053223,33,1.67314563781898,-1.61807360032766 +-148.93644,59.9404795,13.59600874,281713.840228341,1116379.78401156,63.0675239562988,33,1.79980578083913,-1.15800780847439 +-148.80382,59.9353678,9.722133787,289122.036348656,1116379.80014751,34.7780380249023,33,1.54130507798318,-2.09695614469354 +-148.73753,59.9327624,12.33086433,292825.885534291,1116379.77771735,42.3071556091309,33,1.62641382786536,-1.78781687266573 +-148.53872,59.9247488,13.719616,303937.628278666,1116379.75990734,97.3076629638672,33,1.9881470422404,-0.473898589116916 +-148.47247,59.9220117,13.719616,307641.632655455,1116379.75871012,66.8849716186523,33,1.82532854712084,-1.06530183641643 +-148.40623,59.9192417,13.7000239,311345.693715396,1116379.76519704,162.069839477539,133,2.20970220197255,0.330852989168749 +-148.34,59.9164388,11.32220831,315049.818691236,1116379.77923927,88.0420150756836,133,1.94468997397939,-0.631747064923082 +-148.27378,59.9136029,7.342511243,318754.015775992,1116379.7895843,62.4071044921875,33,1.79523403304976,-1.17461370135208 +-147.34801,59.8704506,13.64060079,370609.798576316,1116379.78000052,17.9897174835205,33,1.25502434309477,-3.13680948646514 +-147.28198,59.8671221,13.719616,374313.696973891,1116379.76103547,63.319694519043,33,1.80153881097532,-1.1517129483637 +-147.21596,59.863761,13.719616,378017.778192125,1116379.77906525,154.437423706055,33,2.18875254819951,0.254757867038537 +-147.14995,59.860367,13.719616,381722.052763434,1116379.80090061,221.445663452148,140,2.34526717995949,0.82326368331432 +-147.08396,59.8569403,13.719616,385425.97026031,1116379.79095936,202.757537841797,140,2.30697700878823,0.684182852517373 +-147.01799,59.8534809,13.719616,389129.537787304,1116379.74778834,178.005584716797,140,2.2504336280035,0.478801154419595 +-146.95202,59.8499888,13.719616,392833.872999111,1116379.78825555,143.466079711914,140,2.15674923113757,0.138512684813445 +-146.88607,59.8464639,13.719616,396537.873635552,1116379.78375115,81.0462875366211,41,1.90873312604096,-0.762352599741627 +-146.82014,59.8429063,13.719616,400241.545617342,1116379.74399565,74.4118881225586,41,1.87164232443817,-0.89707697793175 +-146.75421,59.8393161,13.719616,403946.0053711,1116379.80037238,70.0750579833984,41,1.84556346578815,-0.99180283619596 +-146.68831,59.8356932,13.719616,407649.59534941,1116379.75959455,73.6535568237305,41,1.86719372431674,-0.913235563329662 +-146.62241,59.8320375,13.719616,411353.98970604,1116379.79334814,73.7091751098633,41,1.86752155097401,-0.912044803339445 +-146.55654,59.8283493,13.719616,415057.52597155,1116379.74949558,72.8785705566406,41,1.86259984577818,-0.929921841405211 +-146.49067,59.8246283,13.719616,418761.880772029,1116379.78087603,70.4305038452148,41,1.84776079525608,-0.983821508388168 +-146.42482,59.8208748,13.719616,422465.946841427,1116379.79564644,66.9540481567383,41,1.8257768403321,-1.06367350751751 +-146.35899,59.8170886,13.719616,426169.733750518,1116379.77030216,65.5180587768555,41,1.81636102130747,-1.09787444975728 +-146.29317,59.8132698,13.719616,429873.802546746,1116379.7794183,63.7441291809082,41,1.80444019252962,-1.14117430242173 +-146.22737,59.8094184,13.719616,433577.604982101,1116379.75813266,55.6074867248535,41,1.74513326684109,-1.35659398440436 +-146.16158,59.8055343,13.719616,437281.704675202,1116379.75995368,54.3882217407227,41,1.73550485949881,-1.39156710809257 +-146.09581,59.8016178,13.719616,440985.549420011,1116379.75225316,66.5003814697266,41,1.82282413657712,-1.07439857034115 +-146.03005,59.7976686,13.719616,444689.705461227,1116379.76747933,83.5842742919922,41,1.9221245761156,-0.713711030770153 +-145.96431,59.7936868,13.719616,448393.623218835,1116379.74971276,84.1545333862305,140,1.92507751629037,-0.702985109202348 +-145.89858,59.7896726,13.719616,452097.862257742,1116379.78806583,99.6504974365234,140,1.99847947095821,-0.436368258845041 +-145.83287,59.7856257,13.719616,455801.878356439,1116379.78112971,105.306106567383,140,2.02245355610117,-0.349287538720643 +-145.76718,59.7815464,13.719616,459505.67440152,1116379.76107079,105.995315551758,140,2.02528667210461,-0.338996852744356 +-145.7015,59.7774345,13.719616,463209.815389305,1116379.77432716,106.719078063965,140,2.02824206475967,-0.328262023068112 +-145.63584,59.7732902,13.719616,466913.750227627,1116379.77335922,112.738098144531,140,2.05207070413769,-0.241709603476347 +-145.57019,59.7691133,13.719616,470618.043948728,1116379.80576003,117.564018249512,140,2.07027442151223,-0.175588506113774 +-145.50457,59.764904,13.719616,474321.590131777,1116379.75148065,116.571090698242,140,2.06659085996912,-0.188968253031479 +-145.43895,59.7606622,13.719616,478026.062960756,1116379.81264545,116.10147857666,140,2.06483775060503,-0.195336046629097 +-145.37336,59.7563879,13.719616,481729.803550271,1116379.77395711,113.544441223145,140,2.05516587739144,-0.230467050768322 +-145.30778,59.7520812,13.719616,485433.927935171,1116379.79000597,111.852424621582,140,2.04864540272287,-0.254151275893342 +-145.24222,59.7477421,13.719616,489137.887742509,1116379.78781052,127.826065063477,140,2.10661942001202,-0.0435730976671621 +-145.17668,59.7433706,13.719616,492841.68987194,1116379.76638586,172.591125488281,140,2.23701846084294,0.430073438222525 +-145.11115,59.7389666,13.719616,496545.897987991,1116379.78844982,168.508056640625,140,2.22662067001994,0.392305694128387 +-145.04564,59.7345303,13.719616,500249.960731536,1116379.80156449,152.869003295898,140,2.18431943399148,0.238655530898206 +-144.98015,59.7300616,13.719616,503953.886470944,1116379.79371108,134.266815185547,140,2.12796868755587,0.0339735357397289 +-144.91468,59.7255605,13.719616,507657.68208898,1116379.76397147,110.773635864258,140,2.04443641056307,-0.269439536783704 +-144.84922,59.721027,13.719616,511361.909740859,1116379.78844372,89.7287063598633,41,1.9529314064691,-0.60181182978142 +-144.78378,59.7164613,13.719616,515066.017930188,1116379.81250896,81.4333801269531,41,1.91080246181012,-0.754836181580824 +-144.71836,59.7118631,13.719616,518770.018134654,1116379.80206932,55.7552299499512,41,1.74628561130537,-1.35240834039826 +-144.65296,59.7072327,13.719616,522473.912546301,1116379.78949339,120.335342407227,41,2.08039319806485,-0.138834221488304 +-144.58758,59.70257,13.719616,526177.709540307,1116379.76286633,142.312210083008,140,2.1532421632198,0.125774013119279 +-144.52221,59.697875,13.719616,529881.971217318,1116379.80115289,144.033706665039,140,2.15846413727328,0.144741713381305 +-144.45687,59.6931477,13.719616,533585.593843223,1116379.74452744,139.697570800781,141,2.14518885423882,0.0965220962571053 +-144.39154,59.6883882,13.719616,537289.693174263,1116379.76339909,135.434234619141,141,2.13172845775307,0.0476300942412249 +-144.32623,59.6835964,13.719616,540993.722334595,1116379.76613669,146.326293945312,141,2.16532237321557,0.16965278385911 +-144.26094,59.6787724,13.719616,544697.686496146,1116379.76304473,151.680435180664,141,2.18092956601383,0.226342562838751 +-144.19567,59.6739161,13.719616,548401.594072526,1116379.74231614,158.110885620117,141,2.19896177127315,0.291840679244399 +-144.13041,59.6690277,13.719616,552106.003825818,1116379.8084784,153.530166625977,141,2.18619372125952,0.245463477230584 +-144.06518,59.6641071,13.719616,555809.813596073,1116379.78404378,139.546203613281,141,2.14471802590362,0.0948119133558744 +-143.99997,59.6591542,13.719616,559513.587092467,1116379.73983575,134.670715332031,141,2.12927316697458,0.0387117773239749 +-143.93477,59.6541693,13.719616,563217.881309744,1116379.79314781,144.03694152832,141,2.15847389101447,0.144777141753286 +-143.8696,59.6491521,13.719616,566921.597472338,1116379.74108948,149.741271972656,141,2.17534151790889,0.206045177133853 +-143.80444,59.6441029,13.719616,570625.847777311,1116379.78634204,148.201705932617,141,2.1708532027854,0.189742335512678 +-143.73931,59.6390215,13.719616,574329.531783929,1116379.73487531,140.880294799805,141,2.14885025174538,0.109821337067848 +-143.67419,59.633908,13.719616,578033.765045539,1116379.76952378,143.602996826172,141,2.15716350321749,0.14001743925274 +-143.60909,59.6287624,13.719616,581737.998979558,1116379.80375797,135.312408447266,141,2.13133762418876,0.0462104751806426 +-143.54402,59.6235848,13.719616,585441.683245328,1116379.75987712,162.965255737305,240,2.21209502250231,0.339544396311799 +-143.47896,59.6183751,13.719616,589145.936812608,1116379.80201046,216.111709594727,240,2.33467829892674,0.784801845035852 +-143.41393,59.6131333,13.719616,592849.655807605,1116379.75273327,253.32177734375,240,2.40367252644148,1.03540857228249 +-143.34891,59.6078595,13.719616,596553.955673005,1116379.80052333,256.860534667969,240,2.40969738222444,1.05729256815127 +-143.28392,59.6025537,13.719616,600257.732492838,1116379.76575141,248.858383178711,241,2.39595227520635,1.00736641621742 +-143.21895,59.5972159,13.719616,603961.548176528,1116379.73717106,272.579162597656,241,2.43549265298528,1.15098835425794 +-143.15399,59.5918461,13.719616,607665.964628584,1116379.80578248,307.470733642578,241,2.48780378410356,1.34099731356286 +-143.08906,59.5864443,13.719616,611369.877918243,1116379.7886573,345.294891357422,341,2.53819015300426,1.52401498711171 +-143.02415,59.5810106,13.719616,615073.848100414,1116379.787299,403.439208984375,341,2.60577810363894,1.76951371533858 +-142.95926,59.5755449,13.719616,618777.883605986,1116379.79022099,503.21142578125,440,2.7017504935211,2.1181128286379 +-142.89439,59.5700473,13.719616,622481.989181528,1116379.80801145,586.577026367188,440,2.76832504957985,2.35993061851342 +-142.82955,59.5645178,13.719616,626185.616120679,1116379.74595327,652.731018066406,440,2.81473425105204,2.5285020847653 +-142.76472,59.5589564,13.719616,629889.881542325,1116379.79165538,682.101806640625,440,2.83384919982145,2.59793303464537 +-142.63514,59.547738,13.719616,637297.575780959,1116379.74266768,613.962768554688,341,2.78814203579669,2.43191156878398 +-142.57038,59.542081,13.719616,641001.57295838,1116379.74151659,124.694152832031,141,2.09584608898519,-0.0827049109714378 +-142.44092,59.5306715,13.719616,648409.898163525,1116379.79515166,632.421997070312,341,2.8010069672692,2.47864067190916 +-142.37623,59.524919,13.719616,652113.683945665,1116379.75108211,480.04296875,440,2.68128011290854,2.04375856342473 +-142.31156,59.5191348,13.719616,655817.59476699,1116379.73836405,216.042572021484,241,2.33453933898542,0.784297102865861 +-142.24691,59.5133188,13.719616,659521.639055717,1116379.74568988,187.959869384766,141,2.27406513455534,0.564637531319389 +-142.18228,59.5074711,13.719616,663225.821319133,1116379.78378507,187.680450439453,141,2.27341903709421,0.562290720925959 +-142.11768,59.5015916,13.719616,666929.594719564,1116379.74095176,183.992660522461,141,2.26480049932383,0.530985731768378 +-142.0531,59.4956804,13.719616,670633.519009066,1116379.72725085,178.496322631836,141,2.25162927323727,0.483144079179774 +-141.98854,59.4897375,13.719616,674337.60062616,1116379.74244228,175.939102172852,141,2.24536237141121,0.460380902995667 +-141.924,59.4837629,13.719616,678041.846004021,1116379.78630108,177.542114257812,141,2.2493013873649,0.474688533246551 +-141.85949,59.4777566,13.719616,681745.706293696,1116379.75596179,179.269149780273,141,2.2535055587593,0.489959283740989 +-141.795,59.4717187,13.719616,685449.741150994,1116379.76376258,176.727752685547,141,2.24730475489315,0.467436194213499 +-141.73053,59.4656492,13.719616,689153.956960914,1116379.80951739,174.219573974609,141,2.24109694740871,0.444887665545367 +-141.66609,59.459548,13.719616,692857.806890977,1116379.77773725,176.470474243164,141,2.24667205280643,0.465138039643378 +-141.60167,59.4534152,13.719616,696561.850548709,1116379.78247221,175.327362060547,141,2.24384969855015,0.454886443404465 +-141.53728,59.4472509,13.719616,700265.536940017,1116379.72912164,174.251373291016,141,2.24117620949808,0.445175568077598 +-141.4729,59.441055,13.719616,703969.985046335,1116379.81690029,178.166885375977,141,2.25082698794499,0.480229950003195 +-141.40856,59.4348275,13.719616,707673.535395045,1116379.72769052,218.667877197266,141,2.33978498888757,0.803350800568009 +-141.34423,59.4285685,13.719616,711377.858050689,1116379.79037962,262.678771972656,141,2.41942497728685,1.09262596994997 +-141.27993,59.422278,13.719616,715081.848774447,1116379.79120178,318.509033203125,340,2.50312175382879,1.39663655178874 +-141.21566,59.4159559,13.719616,718785.516014611,1116379.71743502,331.213500976562,340,2.52010803125329,1.4583355597608 +-141.1514,59.4096024,13.719616,722489.972360626,1116379.80687907,308.719482421875,240,2.48956403745531,1.34739105616272 +-141.08718,59.4032175,13.719616,726193.558248316,1116379.73311085,283.401550292969,240,2.45240222164129,1.21240873408797 +-141.02297,59.3968011,13.719616,729897.947939491,1116379.81149696,242.319900512695,142,2.38438908202009,0.965365598101012 +-140.95879,59.3903532,13.719616,733602.037167316,1116379.82276699,191.108306884766,142,2.28127956489807,0.590842401527594 +-140.89464,59.383874,13.719616,737305.827828541,1116379.78717418,177.474258422852,142,2.24913537014815,0.474085511329268 +-140.83051,59.3773633,13.719616,741009.8858172,1116379.79270087,156.763946533203,142,2.19524618830963,0.278344621387897 +-140.76641,59.3708213,13.719616,744713.65769957,1116379.74915664,148.7529296875,142,2.17246552791041,0.195598760570098 +-140.70233,59.3642479,13.719616,748417.707176734,1116379.75663409,145.415786743164,142,2.16261155730205,0.159806326717332 +-140.63827,59.3576432,13.719616,752122.038240716,1116379.82613793,143.376022338867,142,2.15647652764548,0.137522147892842 +-140.57425,59.3510072,13.719616,755825.546526989,1116379.73010469,136.272262573242,142,2.13440746671312,0.0573610194493968 +-140.51024,59.3443398,13.719616,759529.906304631,1116379.79741215,133.054061889648,142,2.1240281372815,0.0196603323981825 +-140.44626,59.3376412,13.719616,763234.008697083,1116379.82187156,129.803649902344,142,2.11328690440704,-0.0193548912549321 +-140.38231,59.3309113,13.719616,766937.862120989,1116379.79095599,127.891090393066,142,2.1068402901557,-0.042770834262703 +-140.31838,59.3241502,13.719616,770642.025731835,1116379.83009127,130.570938110352,142,2.11584652439072,-0.0100576208859425 +-140.25448,59.3173578,13.719616,774345.952678931,1116379.81185726,128.169525146484,142,2.10778477530727,-0.0393401946093167 +-140.19061,59.3105342,13.719616,778049.64680825,1116379.74566216,130.924224853516,142,2.11702001130877,-0.00579518145304766 +-140.12676,59.3036794,13.719616,781753.669513268,1116379.74769593,134.900115966797,142,2.13001232301303,0.041396603031784 +-140.06293,59.2967935,13.719616,785458.024575633,1116379.82905655,145.29817199707,142,2.1622601504537,0.158529916742633 +-139.99914,59.2898764,13.719616,789161.609854912,1116379.74132098,144.721435546875,142,2.16053286180501,0.152255911353296 +-139.93537,59.2829281,13.719616,792865.542003643,1116379.7201084,149.295166015625,142,2.17404574605907,0.201338563925222 +-139.87162,59.2759488,13.719616,796569.822393587,1116379.78747981,172.123275756836,142,2.23583960274622,0.425791489135608 +-139.8079,59.2689383,13.719616,800273.906514426,1116379.80128404,152.605056762695,142,2.18356892475745,0.235929467143553 +-139.74421,59.2618968,13.719616,803977.795684082,1116379.78192706,145.940124511719,142,2.16417471244378,0.165484152360977 +-139.68054,59.2548242,13.719616,807682.053583673,1116379.83866424,154.634796142578,142,2.18930722614343,0.256772615651696 +-139.61691,59.2477205,13.719616,811385.575697372,1116379.72739487,165.860046386719,142,2.21974178250713,0.367319611251911 +-139.55329,59.2405858,13.719616,815090.031474179,1116379.82415705,160.196075439453,142,2.20465187232333,0.312508750375173 +-139.48971,59.2334202,13.719616,818793.75865467,1116379.77193515,148.315551757812,142,2.17118669174645,0.190953662606419 +-139.42615,59.2262235,13.719616,822497.878616987,1116379.79353613,130.156753540039,142,2.11446670758991,-0.0150695093453968 +-139.36262,59.2189959,13.719616,826201.837209321,1116379.78667818,98.4042053222656,40,1.99301365848449,-0.456221649847818 +-139.29912,59.2117373,13.719616,829905.642831174,1116379.73908607,80.0255279541016,40,1.90322854800576,-0.782346798328495 +-139.23564,59.2044478,13.719616,833609.854264223,1116379.78584,71.0973052978516,40,1.85185314058277,-0.968956942089971 +-139.17219,59.1971274,13.719616,837313.922164344,1116379.80119141,62.7173194885254,40,1.79738748851218,-1.16679173645522 +-139.10877,59.1897761,13.719616,841017.852458076,1116379.78381224,58.4011383056641,40,1.76642131209615,-1.27926972782495 +-139.04538,59.182394,13.719616,844721.648569504,1116379.74328541,54.5934753417969,40,1.73714074174548,-1.3856251168454 +-138.98201,59.174981,13.719616,848425.874165176,1116379.79516044,47,40,1.67209785793572,-1.62187943592981 +-138.91867,59.1675372,13.719616,852129.977359331,1116379.82240346,45,40,1.65321251377534,-1.69047639633417 +-138.85536,59.1600625,13.719616,855833.96655018,1116379.81284141,38,40,1.57978359661681,-1.95719118215354 +-138.79208,59.1525571,13.719616,859537.842557759,1116379.7869879,28,40,1.44715803134222,-2.43892509033597 +-138.72883,59.1450209,13.66620944,863241.613757524,1116379.73269347,14,40,1.14612803567824,-3.53235195710261 +-152.53042,59.9953554,8.047944525,81697.6627905056,1112675.77597794,28.827880859375,32,1.45981271852744,-2.3929596544719 +-152.46381,59.9946059,8.521527594,85401.9734324264,1112675.77755032,33.7804870605469,32,1.52866590711133,-2.14286522087861 +-152.39721,59.9938233,8.995110662,89105.8997528799,1112675.78247147,39.5039253234863,32,1.59664025161711,-1.8959629998241 +-152.33061,59.9930074,9.468693731,92810.0055528966,1112675.78112491,41.4835891723633,32,1.6178763246292,-1.81882752126549 +-152.26402,59.9921583,9.9422768,96513.7421764658,1112675.77061936,44.2516441345215,32,1.64592941119848,-1.71693070369777 +-152.19743,59.9912761,10.41585987,100217.67259088,1112675.77603132,67.474006652832,32,1.82913649962545,-1.05147026602182 +-152.13084,59.9903606,10.88944294,103921.804827365,1112675.77550032,60.1281356811523,32,1.77907773842158,-1.23329797490723 +-152.06426,59.9894119,11.36302601,107625.590193604,1112675.76451726,47.736328125,32,1.67884901005447,-1.59735732446382 +-151.99768,59.9884301,11.83660908,111329.59162049,1112675.76988695,39.1563682556152,32,1.59280240428308,-1.90990315677197 +-151.9311,59.9874151,12.31019214,115033.816855286,1112675.78098504,33.3462944030762,32,1.52304758009033,-2.16327258824907 +-151.86453,59.9863668,12.78377521,118737.717854539,1112675.769328,27.179313659668,32,1.43423848559801,-2.48585256808444 +-151.79796,59.9852854,13.25735828,122441.857175319,1112675.77462728,18.0706367492676,32,1.25697345592679,-3.12972975232706 +-149.40551,59.9242896,13.719616,255785.821778965,1112675.77526542,260.833526611328,33,2.41636341331174,1.08150549573503 +-149.20659,59.9172725,13.43598801,266897.909384531,1112675.7896076,159.535552978516,33,2.20285748201251,0.305991012596286 +-149.1403,59.9148674,13.719616,270602.0671474,1112675.79240144,204.014694213867,33,2.30966144873067,0.693933504603781 +-149.07403,59.9124294,13.719616,274305.651784884,1112675.76078758,87.7911071777344,33,1.94345052616535,-0.636249093157315 +-149.00776,59.9099585,13.719616,278009.782221439,1112675.77650433,97.3505401611328,33,1.98833836559769,-0.47320364807411 +-148.9415,59.9074546,13.719616,281713.910726531,1112675.78736002,122.913009643555,33,2.08959785292214,-0.105400287776555 +-148.87525,59.9049177,13.719616,285418.04458401,1112675.79308093,88.2436676025391,33,1.94568355004913,-0.628138113042953 +-148.80902,59.9023479,13.719616,289121.634367438,1112675.76102524,103.306549072266,133,2.01412785429591,-0.379528864069251 +-148.74279,59.8997452,13.719616,292825.798991197,1112675.77746546,121.665924072266,33,2.08516895900557,-0.121487294613726 +-148.67657,59.8971095,13.719616,296529.990759027,1112675.78805477,75.0956649780273,33,1.87561486735755,-0.882647568171924 +-148.61037,59.894441,13.719616,300233.659296753,1112675.76967597,82.6594085693359,33,1.91729229356615,-0.731263260260517 +-148.54417,59.8917395,13.719616,303937.925312906,1112675.78970851,111.352500915527,133,2.04669997549324,-0.261217622871564 +-148.47799,59.8890051,13.719616,307641.683477806,1112675.76815694,104.468734741211,33,2.01898633483926,-0.36188147598739 +-148.41181,59.8862378,13.719616,311346.052692521,1112675.79696114,163.492523193359,133,2.21349789638399,0.34464003467012 +-148.34565,59.8834376,13.719616,315049.928517346,1112675.78278342,68.7083511352539,33,1.83700952645602,-1.02287318538763 +-148.2795,59.8806046,13.719616,318753.873051203,1112675.78297503,104.239837646484,33,2.01803372629153,-0.365341622134288 +-148.21336,59.8777387,13.719616,322457.894457693,1112675.78629608,90.5970306396484,33,1.95711396370387,-0.586619588084051 +-148.14723,59.8748399,12.89672224,326161.999957656,1112675.7926681,68.4532470703125,33,1.83539405365734,-1.02874104369428 +-148.08112,59.8719083,9.188801015,329865.639939178,1112675.76349888,55.4212265014648,33,1.74367613272236,-1.36188671143107 +-147.48661,59.8440468,9.637179875,363201.992548295,1112675.7984206,18.7342643737793,33,1.27263664460459,-3.07283658033016 +-147.42062,59.8407871,13.719616,366905.81975243,1112675.77651991,49.303394317627,33,1.69287681953423,-1.54640431649789 +-147.35464,59.8374947,13.719616,370609.815010506,1112675.77700452,67.89453125,33,1.83183479425697,-1.04166928975018 +-147.28867,59.8341696,13.719616,374313.985437109,1112675.80002019,89.4661712646484,33,1.95165885196032,-0.606434110980542 +-147.22272,59.8308117,13.719616,378017.783448303,1112675.7776846,152.483734130859,140,2.1832235187387,0.234674853894765 +-147.15678,59.8274211,13.719616,381721.770869471,1112675.77711107,203.426895141602,140,2.30840837060943,0.689381967203317 +-147.09085,59.8239977,13.719616,385425.955966628,1112675.78737559,206.687271118164,140,2.315313731328,0.714464208319345 +-147.02494,59.8205417,13.719616,389129.787694985,1112675.77234594,183.742813110352,140,2.26421036115728,0.528842181505256 +-146.95904,59.817053,13.719616,392833.830137276,1112675.77861054,160.359558105469,140,2.20509485081732,0.314117774703977 +-146.89316,59.8135316,13.719616,396537.534553516,1112675.7467106,83.3524551391602,41,1.9209183964578,-0.718092219565237 +-146.82728,59.8099775,13.719616,400242.019703787,1112675.79577586,77.0568618774414,41,1.88681131849658,-0.841978861849643 +-146.76143,59.8063908,13.719616,403945.623955679,1112675.7564064,79.2244720458984,41,1.89885935372139,-0.798216959061539 +-146.69558,59.8027714,13.719616,407650.023091212,1112675.79858843,77.337272644043,41,1.8883888522919,-0.836248808832082 +-146.62976,59.7991194,13.719616,411353.555448894,1112675.7496079,73.1055908203125,41,1.86395059131579,-0.925015548071455 +-146.56394,59.7954347,13.719616,415057.896825687,1112675.78283453,71.0577774047852,41,1.85161161919703,-0.969834216700059 +-146.49814,59.7917175,13.719616,418761.940104865,1112675.7964076,70.6603317260742,41,1.84917567196757,-0.97868227232602 +-146.43236,59.7879676,13.719616,422465.694833201,1112675.76679819,72.5764617919922,41,1.86079579189334,-0.936474680043178 +-146.36659,59.7841851,13.719616,426169.722628725,1112675.7680032,73.3515625,41,1.86540936941176,-0.919716849650178 +-146.30083,59.78037,13.719616,429874.030520819,1112675.8004257,75.181510925293,41,1.87611104949596,-0.880845293020752 +-146.2351,59.7765224,13.719616,433577.512561605,1112675.74501832,56.3765907287598,41,1.75109880916497,-1.33492543194873 +-146.16937,59.7726422,13.719616,437281.84455908,1112675.78529725,59.7322273254395,41,1.77620870924084,-1.24371910779415 +-146.10366,59.7687294,13.719616,440985.921862394,1112675.79058535,82.8879470825195,41,1.91849138343187,-0.726907823613885 +-146.03797,59.7647841,13.719616,444689.750148427,1112675.77078348,85.2876968383789,41,1.93088638661214,-0.681885634177031 +-145.97229,59.7608063,13.719616,448393.892229284,1112675.79222119,82.3740234375,41,1.91579027897422,-0.736719005976059 +-145.90663,59.7567959,13.719616,452097.80060365,1112675.77622487,84.1319885253906,41,1.92496115392688,-0.70340777051967 +-145.84098,59.752753,13.719616,455802.03673843,1112675.80137598,87.1438751220703,41,1.94023686827718,-0.647922015876419 +-145.77535,59.7486777,13.719616,459506.050383716,1112675.81011621,93.4681396484375,140,1.97066359875628,-0.537403446122816 +-145.70974,59.7445698,13.719616,463209.851253337,1112675.7791298,104.648170471191,140,2.01973164011654,-0.359174314488982 +-145.64414,59.7404295,13.719616,466913.999366191,1112675.79981248,107.31372833252,140,2.03065528354734,-0.31949652363008 +-145.57856,59.7362567,13.719616,470617.947223245,1112675.79078958,107.518264770508,140,2.0314822467191,-0.316492757351454 +-145.513,59.7320515,13.719616,474321.700349397,1112675.76208278,114.732009887695,140,2.05968460166886,-0.2140537544204 +-145.44745,59.7278139,13.719616,478025.821492352,1112675.78461489,114.226593017578,140,2.05776722349219,-0.22101821923228 +-145.38192,59.7235438,13.719616,481729.763173818,1112675.7753928,109.890022277832,140,2.04095826142806,-0.282073167204659 +-145.31641,59.7192413,13.719616,485433.530873651,1112675.74448441,107.669631958008,140,2.03209322852723,-0.314273497032777 +-145.25091,59.7149064,13.719616,489137.68732729,1112675.76453607,106.052406311035,140,2.0255205270322,-0.338147424898509 +-145.18543,59.7105391,13.719616,492841.683597007,1112675.76202027,158.616348266602,140,2.20034794714345,0.296875665659296 +-145.11997,59.7061394,13.719616,496545.526575411,1112675.73596373,163.841903686523,140,2.21442498541237,0.34800748663876 +-145.05452,59.7017074,13.719616,500249.777483702,1112675.77181729,144.212249755859,140,2.15900215202988,0.146695936541964 +-144.98909,59.6972431,13.719616,503953.887338796,1112675.79442577,131.846572875977,140,2.12006884554094,0.00527905470209486 +-144.92368,59.6927463,13.719616,507657.866034947,1112675.78070508,123.817977905273,140,2.09278370718979,-0.0938283557431167 +-144.85829,59.6882173,13.719616,511361.715877191,1112675.76298287,122.338310241699,41,2.08756247765129,-0.112793351714223 +-144.79291,59.683656,13.719616,515066.001051267,1112675.80684206,106.362419128418,41,2.02678820645358,-0.333542851408315 +-144.72756,59.6790623,13.719616,518769.618278682,1112675.74577414,139.415176391602,41,2.14431005255951,0.093330037722877 +-144.66222,59.6744364,13.719616,522473.682956802,1112675.75673826,146.642379760742,140,2.16625949988496,0.173056695404926 +-144.5969,59.6697782,13.719616,526177.647621995,1112675.75025683,145.815307617188,140,2.16380311839012,0.164134416694601 +-144.5316,59.6650878,13.719616,529881.517506504,1112675.73656989,146.609176635742,140,2.16616115473578,0.172699477752592 +-144.46631,59.6603651,13.719616,533585.856828662,1112675.78413894,146.302688598633,141,2.1652523072109,0.169398284131324 +-144.40105,59.6556102,13.719616,537289.559121035,1112675.74309949,154.880981445312,141,2.18999809199772,0.25928203762723 +-144.3358,59.6508231,13.719616,540993.742827765,1112675.77391664,169.986602783203,141,2.2304146945159,0.406086674020143 +-144.27057,59.6460037,13.719616,544697.860517344,1112675.78441383,207.468002319336,141,2.31695112520373,0.72041169023473 +-144.20536,59.6411522,13.719616,548401.915701967,1112675.79596559,216.89518737793,141,2.33624991569148,0.790510405709455 +-144.14017,59.6362685,13.719616,552105.916764685,1112675.79677214,235.275146484375,141,2.37157605248509,0.918825017627154 +-144.075,59.6313526,13.719616,555809.870462444,1112675.78611398,285.6474609375,141,2.45583036805792,1.22486074036358 +-144.00985,59.6264046,13.719616,559513.781871788,1112675.77434363,172.906494140625,141,2.23781130511009,0.432953274901071 +-143.94472,59.6214245,13.719616,563217.657707886,1112675.76076892,184.644729614258,141,2.26633691592899,0.536566435415252 +-143.8796,59.6164122,13.719616,566922.062213216,1112675.81902682,173.785934448242,141,2.24001462344343,0.440956355977451 +-143.81451,59.6113678,13.719616,570625.888748829,1112675.78933973,170.839553833008,141,2.23258842854666,0.413982296465328 +-143.74944,59.6062913,13.719616,574329.69985036,1112675.7558715,156.831405639648,141,2.19543303494451,0.279023301697155 +-143.68438,59.6011828,13.719616,578034.056318794,1112675.8160803,149.013671875,141,2.17322611638191,0.198361434992166 +-143.61935,59.5960422,13.719616,581737.85488507,1112675.78478342,133.246002197266,141,2.124654187682,0.0219343261453902 +-143.55434,59.5908696,13.719616,585441.656319019,1112675.75890973,131.685562133789,141,2.11953816198269,0.00335146054636492 +-143.48934,59.5856649,13.719616,589146.024867151,1112675.81554364,199.611724853516,240,2.30018604742045,0.659516142496241 +-143.42437,59.5804282,13.719616,592849.853764544,1112675.78829495,297.946044921875,241,2.47413762476666,1.29135792214101 +-143.35942,59.5751595,13.719616,596553.705485691,1112675.76476422,241.607574462891,241,2.38311054541214,0.960721588210249 +-143.29449,59.5698588,13.719616,600257.586665711,1112675.74441348,271.523315429688,241,2.43380712794954,1.14486604623138 +-143.22957,59.5645261,13.719616,603962.05976934,1112675.81766347,266.394592285156,341,2.42552540456526,1.11478446306045 +-143.16468,59.5591615,13.719616,607666.017936578,1112675.81371285,398.804901123047,341,2.60076048694557,1.7512882993379 +-143.09981,59.5537649,13.719616,611370.025417034,1112675.81141916,474.07958984375,440,2.6758512584005,2.02403941430221 +-143.03497,59.5483364,13.719616,615073.53115376,1112675.72872079,555.366882324219,440,2.74457997830823,2.2736817421368 +-142.97014,59.542876,13.719616,618777.653393877,1112675.74982743,613.297424316406,440,2.78767114077176,2.43020114364659 +-142.90533,59.5373837,13.719616,622481.842875978,1112675.78223124,686.615600585938,440,2.83671366680225,2.60833759631991 +-142.64632,59.5150958,13.719616,637297.731299286,1112675.76154198,276.202911376953,341,2.44122825204233,1.17182168713608 +-142.58162,59.5094443,13.719616,641001.793805103,1112675.77908486,565.449401855469,141,2.75239374899957,2.30206358755992 +-142.32304,59.4865202,13.719616,655818.045001441,1112675.82549328,389.20703125,341,2.59018067744804,1.71285941146459 +-142.25846,59.4807097,13.719616,659521.583779214,1112675.73405842,192.188232421875,141,2.28372679253803,0.59973143082426 +-142.19389,59.4748676,13.719616,663225.811496925,1112675.77950171,191.337966918945,141,2.28180115501087,0.592736965693927 +-142.12935,59.4689937,13.719616,666929.626876469,1112675.74035822,186.999862670898,141,2.2718412875991,0.556559884425206 +-142.06483,59.4630882,13.719616,670633.588228751,1112675.73768388,182.408843994141,141,2.26104589103593,0.517347922794798 +-142.00033,59.457151,13.719616,674337.703967491,1112675.76022688,181.665954589844,141,2.25927354525437,0.510910257038329 +-141.93585,59.4511821,13.719616,678041.980523763,1112675.80775567,183.576202392578,141,2.26381638144339,0.527411134731397 +-141.8714,59.4451816,13.719616,681745.866458068,1112675.78839361,183.602752685547,141,2.26387918812438,0.527639266523574 +-141.80697,59.4391495,13.719616,685449.923993251,1112675.80347313,184.086166381836,141,2.26502115357862,0.53178721100274 +-141.74257,59.4330857,13.719616,689153.605729793,1112675.73803925,185.563201904297,141,2.26849185768899,0.54439379896918 +-141.67818,59.4269904,13.719616,692858.025620872,1112675.820883,181.795654296875,141,2.25958349749186,0.51203609203409 +-141.61383,59.4208635,13.719616,696561.524576464,1112675.72786198,182.089538574219,141,2.26028499538306,0.514584132602351 +-141.54949,59.414705,13.719616,700265.776466763,1112675.77181403,182.681076049805,141,2.26169356107552,0.519700445242016 +-141.48518,59.408515,13.719616,703969.673889363,1112675.75325837,188.019668579102,141,2.27420328281991,0.565139325247738 +-141.42089,59.4022935,13.719616,707673.779002583,1112675.77695654,249.126327514648,141,2.39641962593133,1.00906396744571 +-141.35663,59.3960404,13.719616,711377.544406049,1112675.72470191,306.310150146484,240,2.48616138818617,1.33503166280443 +-141.29239,59.3897559,13.719616,715081.528026021,1112675.72436099,328.098541259766,340,2.51600429949838,1.44342963470531 +-141.22817,59.3834399,13.719616,718785.738274951,1112675.76487166,315.627319335938,340,2.49917458681671,1.38229931456723 +-141.16398,59.3770925,13.719616,722489.623472351,1112675.74834971,302.710754394531,240,2.48102785039574,1.316385188292 +-141.09981,59.3707136,13.719616,726193.747875255,1112675.77144137,266.143951416016,142,2.42511660052381,1.11329957009764 +-141.03567,59.3643033,13.719616,729897.55977079,1112675.73517174,210.570404052734,142,2.32339733047805,0.743826147721242 +-140.97155,59.3578615,13.719616,733601.62342595,1112675.73733566,157.851913452148,142,2.19824985069876,0.289254780515849 +-140.90745,59.3513884,13.719616,737305.940739916,1112675.79985322,163.768676757812,142,2.21423083996351,0.34730229495388 +-140.84338,59.344884,13.719616,741009.962088227,1112675.81113816,160.441787719727,142,2.205317492455,0.314926472680304 +-140.77934,59.3383482,13.719616,744713.695886401,1112675.75856459,149.679962158203,142,2.17516366469448,0.205399163494773 +-140.71532,59.331781,13.719616,748417.704199331,1112675.75318215,144.437164306641,142,2.15967895345967,0.149154272513317 +-140.65132,59.3251826,13.719616,752121.988787222,1112675.81694436,140.450805664062,142,2.14752423477614,0.105004864952628 +-140.58735,59.3185528,13.719616,755826.004456746,1112675.8141776,138.257659912109,142,2.14068920193265,0.0801780747524895 +-140.52341,59.3118918,13.719616,759529.752914425,1112675.76518181,133.405319213867,142,2.12517314636595,0.0238193322110489 +-140.45949,59.3051995,13.719616,763233.798402759,1112675.77233217,128,142,2.10720996964787,-0.0414280528301153 +-140.3956,59.298476,13.719616,766937.58898284,1112675.73118437,127.40283203125,142,2.10517908201718,-0.0488048163778056 +-140.33173,59.2917213,13.719616,770641.68662177,1112675.75620613,127.60408782959,142,2.1058645873428,-0.0463148653724611 +-140.26789,59.2849353,13.719616,774345.543907227,1112675.71996988,124.377334594727,142,2.09474124565,-0.0867180173185396 +-140.20407,59.2781182,13.719616,778049.71821438,1112675.75997367,123.398727416992,142,2.09131068094011,-0.0991788075255017 +-140.14028,59.2712699,13.719616,781753.662108711,1112675.7477001,124.736663818359,142,2.09599412431786,-0.0821672043896658 +-140.07651,59.2643905,13.719616,785457.935207053,1112675.81083914,131.189407348633,142,2.11789877013297,-0.00260327858082275 +-140.01277,59.2574799,13.719616,789161.990084156,1112675.81979008,131.102157592773,142,2.11760983908082,-0.00365275863137682 +-139.94906,59.2505382,13.719616,792865.830489574,1112675.78399383,136.070495605469,142,2.13376396660794,0.0550236433941778 +-139.88537,59.2435654,13.719616,796570.018317858,1112675.82191259,151.595901489258,142,2.18068745997242,0.225463164592378 +-139.82171,59.2365616,13.719616,800274.001419816,1112675.82417338,145.948516845703,142,2.16419968597015,0.165574863336901 +-139.75808,59.2295267,13.719616,803977.788191502,1112675.77838934,140.476974487305,142,2.1476051450767,0.105298754258387 +-139.69447,59.2224607,13.719616,807681.940509626,1112675.80473686,139.919769287109,142,2.14587908036557,0.0990291945596452 +-139.63089,59.2153638,13.719616,811385.903775537,1112675.80312316,144.337417602539,142,2.15937893089802,0.148064504934433 +-139.56734,59.2082358,13.719616,815089.688777999,1112675.75028495,148.037658691406,142,2.17037220783726,0.187995224571413 +-139.50381,59.2010769,13.719616,818793.852533592,1112675.78994206,138.655395507812,142,2.14193677397647,0.0847096125081477 +-139.44031,59.193887,13.719616,822497.847594815,1112675.78760361,112.344268798828,142,2.05055092194846,-0.247229886176635 +-139.37684,59.1866662,13.719616,826201.677500561,1112675.75279795,105.425750732422,142,2.022946702291,-0.347496291001248 +-139.31339,59.1794144,13.719616,829905.906481102,1112675.79820702,91.0415878295898,40,1.95923982351953,-0.578897858452768 +-139.24997,59.1721318,13.719616,833609.97974513,1112675.82043693,81.2198333740234,40,1.90966209418115,-0.758978322302569 +-139.18658,59.1648182,13.719616,837313.90813898,1112675.7963259,73.5702590942383,40,1.86670228551103,-0.915020609342615 +-139.12322,59.1574739,13.719616,841017.690168527,1112675.75724704,64.4986343383789,40,1.80955051919984,-1.12261213732303 +-139.05988,59.1500986,13.719616,844721.895006705,1112675.79636531,61.9563102722168,40,1.79208554601212,-1.18604990494049 +-138.99657,59.1426926,13.719616,848425.965250302,1112675.81898519,60.7290229797363,40,1.78339629416517,-1.21761174780799 +-138.93329,59.1352557,13.719616,852129.911773137,1112675.80200966,55.849250793457,40,1.74701735151698,-1.34975045109021 +-138.87004,59.1277881,13.719616,855833.735425814,1112675.76593731,52.9247398376465,40,1.72365873183359,-1.43459562499413 +-138.80681,59.1202897,13.719616,859538.000410453,1112675.82802217,48.9494514465332,40,1.68974782923255,-1.55776970237636 +-138.74362,59.1127605,13.719616,863241.6009152,1112675.72870389,53.7295074462891,40,1.73021285928563,-1.41078916335411 +-138.68045,59.1052007,13.719616,866945.649347884,1112675.74790952,56.7236213684082,40,1.75376394943368,-1.325244881786 +-138.61731,59.0976101,13.719616,870649.600789448,1112675.73319716,41,40,1.61278385671974,-1.83732481824772 +-138.55419,59.0899888,13.719616,874354.014336152,1112675.82587757,39,40,1.5910646070265,-1.9162153324246 +-138.49111,59.0823369,13.19136914,878057.781533162,1112675.77284858,25,40,1.39794000867204,-2.61769899689636 +-138.42805,59.0746543,10.66043657,881762.022410847,1112675.82589542,13,40,1.11394335230684,-3.64925591353076 +-138.36503,59.0669412,8.485346786,885465.625873571,1112675.7405763,14,40,1.14612803567824,-3.53235195710261 +-152.59843,59.9629585,13.719616,77993.8475755517,1108971.77675621,17.3453121185303,32,1.23918211911817,-3.19435296576908 +-152.53189,59.962243,13.719616,81697.8105436195,1108971.77937765,24.0995349884033,32,1.38200866274421,-2.67556619256506 +-152.46535,59.9614943,13.719616,85401.9375920344,1108971.7830997,21.4268493652344,32,1.33095831645075,-2.86099562152245 +-152.39882,59.9607124,13.719616,89105.6797635129,1108971.77492771,38.2242622375488,32,1.58233911189329,-1.94790882125268 +-152.33229,59.9598973,13.719616,92809.6008844734,1108971.76760486,75.7581481933594,32,1.87942935037702,-0.868792277083368 +-152.26576,59.9590491,13.719616,96513.7080962657,1108971.77277074,72.2398986816406,32,1.85877712819643,-0.943807042774333 +-152.19923,59.9581677,13.719616,100218.009100992,1108971.77972402,79.3324127197266,32,1.89945066259236,-0.796069156465791 +-152.13271,59.9572532,13.719616,103921.95462362,1108971.78449275,58.1243286132812,32,1.76435794944672,-1.28676444990999 +-152.0662,59.9563054,13.719616,107625.552712443,1108971.76356167,44.3239936828613,32,1.64663888430812,-1.71435369485979 +-151.99968,59.9553246,13.719616,111329.922604889,1108971.78285559,32.4757118225098,32,1.5115586789814,-2.20500355633556 +-151.93317,59.9543105,13.719616,115033.959922006,1108971.77642244,34.5950050354004,32,1.5390133981523,-2.10528017994983 +-151.86667,59.9532634,13.719616,118737.671047547,1108971.7766948,17.9137783050537,32,1.25318719522802,-3.14348253189137 +-151.80017,59.952183,13.719616,122441.620844381,1108971.76749345,14.733603477478,32,1.16830897759566,-3.4517844449874 +-149.67519,59.900133,10.84560697,240969.810089331,1108971.77230346,122.586700439453,33,2.08844335567127,-0.109593751318036 +-149.54263,59.8957563,9.73840501,248377.687135372,1108971.77072448,53.1338653564453,33,1.7253714109015,-1.42837468577219 +-149.47636,59.8935184,13.719616,252081.808248891,1108971.77345811,195.219879150391,33,2.29052403958957,0.624420972242903 +-149.4101,59.8912476,13.51462814,255785.87434379,1108971.78075335,255.411804199219,33,2.4072409648934,1.04837015927362 +-149.34385,59.8889438,11.96489435,259489.893467267,1108971.78104853,76.505729675293,33,1.88369396160043,-0.853301991878717 +-149.21138,59.8842374,13.719616,266897.818365702,1108971.78142294,130.56135559082,133,2.11581465062054,-0.0101733955168873 +-149.14516,59.8818347,13.719616,270601.739495611,1108971.76962916,209.107131958008,133,2.32036884542976,0.732825825610136 +-149.07895,59.8793991,13.719616,274305.641969186,1108971.76055299,200.16389465332,133,2.30138574263907,0.663873777957373 +-149.01275,59.8769306,13.719616,278009.533038364,1108971.75387898,104.242172241211,133,2.01804345280566,-0.365306292658753 +-148.94655,59.8744292,13.719616,281713.976344869,1108971.79172942,134.21696472168,133,2.12780741314567,0.0333877410495774 +-148.88037,59.8718948,13.719616,285417.867212441,1108971.77839345,118.217269897461,133,2.07268092555797,-0.166847396535025 +-148.8142,59.8693276,13.719616,289121.767566394,1108971.77777226,167.304107666016,133,2.22350660393182,0.380994517253382 +-148.74804,59.8667274,13.719616,292825.686382225,1108971.76732373,168.643844604492,133,2.22697049433584,0.393576355893562 +-148.68189,59.8640943,13.719616,296529.630037981,1108971.75797243,109.656272888184,133,2.04003348054433,-0.285432235333094 +-148.61575,59.8614284,13.719616,300233.604864672,1108971.76065733,106.811592102051,133,2.02861838857978,-0.326895107539975 +-148.54962,59.8587296,13.719616,303937.618979786,1108971.76404096,130.074157714844,133,2.11419102233682,-0.0160708768730124 +-148.4835,59.8559979,13.719616,307641.679614654,1108971.76795193,153.757934570312,133,2.18683753648771,0.247801997902512 +-148.41739,59.8532333,13.719616,311345.793997894,1108971.77223675,87.1879577636719,33,1.94045650513967,-0.647124232101264 +-148.35129,59.8504359,13.719616,315049.968405324,1108971.78790243,125.542114257812,33,2.09878943834026,-0.0720138259982791 +-148.28521,59.8476057,13.719616,318753.653634514,1108971.76683135,104.960227966309,133,2.02102476528999,-0.354477314764353 +-148.21913,59.8447426,13.719616,322457.970629175,1108971.79321667,80.8674163818359,33,1.90777356813799,-0.765837987930306 +-148.15307,59.8418467,13.719616,326161.81283895,1108971.78156414,84.0835418701172,33,1.92471099729052,-0.704316410824743 +-148.08702,59.8389179,13.719616,329865.744831758,1108971.76866519,146.24755859375,133,2.16508862485259,0.16880374308637 +-148.02098,59.8359564,13.719616,333569.771808338,1108971.77674884,116.845825195312,133,2.06761320002282,-0.185254822151542 +-147.95495,59.832962,13.67345484,337273.90294398,1108971.78350736,32.1191024780273,33,1.50676340104356,-2.22242137451438 +-147.625,59.8174985,12.88687541,355793.569704451,1108971.75242747,28.9924983978271,33,1.46228564183439,-2.38397729117851 +-147.55904,59.8143075,13.719616,359497.911731705,1108971.78373353,32.9851341247559,33,1.51831825435623,-2.18045084919929 +-147.4931,59.8110838,13.719616,363201.849536848,1108971.78044838,53.3717308044434,33,1.72731128687012,-1.42132850255847 +-147.42717,59.8078274,13.719616,366905.946629891,1108971.79625318,74.4631805419922,33,1.87194158227637,-0.895989988046733 +-147.36126,59.8045382,13.719616,370609.654849176,1108971.76433978,79.1807708740234,33,1.89861972556351,-0.799087356927636 +-147.29536,59.8012163,13.719616,374313.536604337,1108971.7506692,78.4058074951172,33,1.89434823194047,-0.814602640972173 +-147.22947,59.7978617,13.719616,378017.599003446,1108971.7554008,127.164512634277,140,2.10436593114421,-0.0517584124448089 +-147.16359,59.7944744,13.719616,381721.849151275,1108971.77871142,189.587387084961,140,2.27780944111592,0.578237921478894 +-147.09773,59.7910545,13.719616,385425.73659687,1108971.77388147,208.259780883789,140,2.31860540712136,0.726420514338638 +-147.03188,59.7876018,13.719616,389129.827139876,1108971.77579762,189.066864013672,140,2.2766154207699,0.573900898774796 +-146.96605,59.7841165,13.719616,392833.569151412,1108971.74778095,143.039703369141,140,2.15545660082769,0.133817482574544 +-146.90023,59.7805986,13.719616,396537.526081967,1108971.74811094,88.4466705322266,41,1.94668148906375,-0.624513313701694 +-146.83442,59.777048,13.719616,400241.706190598,1108971.76593034,82.7459487915039,41,1.91774674008444,-0.729612580794135 +-146.76863,59.7734648,13.719616,403945.55895419,1108971.75181201,83.8455276489258,41,1.92347990213359,-0.708788099824247 +-146.70285,59.7698489,13.719616,407649.649039116,1108971.75464538,81.2944183349609,41,1.91006072801051,-0.757530370452902 +-146.63708,59.7662005,13.719616,411353.981048176,1108971.79697464,74.4485931396484,41,1.87185649527207,-0.896299048332584 +-146.57133,59.7625195,13.719616,415058.006845172,1108971.80551468,72.4260482788086,41,1.85989478980479,-0.939747376800389 +-146.5056,59.7588058,13.719616,418761.73472658,1108971.76782768,75.1785583496094,41,1.87609399327441,-0.880907246085753 +-146.43988,59.7550596,13.719616,422465.725610683,1108971.76844269,76.935791015625,41,1.88612842334474,-0.844459331958814 +-146.37417,59.7512808,13.719616,426169.987775705,1108971.79662831,79.2604446411133,41,1.89905650434236,-0.797500851733776 +-146.30848,59.7474695,13.719616,429873.970563434,1108971.79916154,77.3889923095703,41,1.88867919170115,-0.83519421322657 +-146.24281,59.7436256,13.719616,433577.682266717,1108971.76367462,79.6209106445312,41,1.90102714041253,-0.790342939051393 +-146.17715,59.7397492,13.719616,437281.684982439,1108971.765877,78.7200622558594,41,1.89608542888575,-0.808292645821528 +-146.1115,59.7358402,13.719616,440985.987017934,1108971.79511097,80.241340637207,41,1.90439817607514,-0.778098375335403 +-146.04587,59.7318988,13.719616,444690.036319956,1108971.80708824,76.2681274414062,41,1.88234308358751,-0.858208766400603 +-145.98026,59.7279248,13.719616,448393.8425244,1108971.77840952,73.9354553222656,41,1.86885275176696,-0.907209502096915 +-145.91466,59.7239184,13.719616,452097.966310986,1108971.79817797,74.0740051269531,41,1.86966582726952,-0.904256179796732 +-145.84908,59.7198795,13.719616,455801.859590502,1108971.7871718,78.3926773071289,41,1.89427549694931,-0.814866835220699 +-145.78352,59.7158081,13.719616,459505.529325926,1108971.74424888,83.4433059692383,140,1.92139150222283,-0.716373764388831 +-145.71797,59.7117043,13.719616,463209.537477629,1108971.74912852,90.7679138183594,140,1.95793235387014,-0.583646961408344 +-145.65243,59.707568,13.719616,466913.892369757,1108971.79127723,95.7972030639648,140,1.98135282941656,-0.498577109354517 +-145.58691,59.7033993,13.719616,470618.043148372,1108971.81150529,104.10221862793,140,2.0174599852992,-0.367425613180422 +-145.52141,59.6991981,13.719616,474321.998151539,1108971.79764248,111.486740112305,140,2.04722321681464,-0.259317061044296 +-145.45593,59.6949646,13.719616,478025.761452942,1108971.7708111,107.918113708496,140,2.03309434573399,-0.310637153590531 +-145.39046,59.6906987,13.719616,481729.897763882,1108971.79141069,108.026496887207,140,2.03353029289903,-0.309053669055386 +-145.32501,59.6864004,13.719616,485433.857594265,1108971.78699068,108.395866394043,140,2.03501272098017,-0.303669067137585 +-145.25958,59.6820697,13.719616,489137.647842131,1108971.75653934,109.990364074707,140,2.04135463959016,-0.28063340858232 +-145.19416,59.6777067,13.719616,492841.830315231,1108971.78435662,124.85913848877,140,2.09642033403221,-0.0806190890548135 +-145.12876,59.6733113,13.719616,496545.85696762,1108971.78528176,170.752243041992,140,2.23236641738643,0.413175888563084 +-145.06338,59.6688836,13.719616,500249.73318463,1108971.76943424,150.058868408203,140,2.17626166711797,0.20938742169798 +-144.99801,59.6644236,13.719616,503954.022207104,1108971.81174853,146.206909179688,140,2.16496789620401,0.168365222175317 +-144.93267,59.6599312,13.719616,507657.619616947,1108971.74900311,144.017349243164,140,2.15841481311411,0.144562553956664 +-144.86734,59.6554066,13.719616,511361.642005623,1108971.7547652,150.557998657227,140,2.17770383311626,0.214625780238924 +-144.80203,59.6508497,13.719616,515065.541327819,1108971.74117114,139.744812011719,41,2.14533569379277,0.0970554594292472 +-144.73673,59.6462605,13.719616,518769.880807287,1108971.78545238,144.933395385742,140,2.16116846663535,0.154564609516771 +-144.67146,59.6416391,13.719616,522473.552921118,1108971.74214178,145.90510559082,140,2.1640704892281,0.165105583893354 +-144.6062,59.6369854,13.719616,526177.67882039,1108971.75610125,145.547164916992,140,2.16300375032517,0.161230883720336 +-144.54096,59.6322995,13.719616,529881.70734392,1108971.75945056,149.39241027832,140,2.174328534173,0.202365731070786 +-144.47574,59.6275814,13.719616,533585.645273055,1108971.75136715,147.011276245117,141,2.16735064783124,0.177020056190442 +-144.41053,59.6228311,13.719616,537290.055776938,1108971.81194845,162.592651367188,141,2.21110091307354,0.335933507119434 +-144.34535,59.6180486,13.719616,540993.832843523,1108971.77915489,256.801361083984,241,2.40959732122586,1.05692911804414 +-144.28019,59.613234,13.719616,544697.538002237,1108971.74362123,383.528472900391,341,2.58379761121721,1.68967429300573 +-144.21504,59.6083871,13.719616,548401.737659405,1108971.7650402,492.046997070312,341,2.69200658568104,2.08272017417461 +-144.14991,59.6035081,13.719616,552105.878909299,1108971.78333256,574.727783203125,341,2.75946219208786,2.32773819039111 +-143.95464,59.5886785,13.719616,563218.019410095,1108971.81223028,606.48193359375,241,2.78281786825716,2.41257267261169 +-143.88959,59.5836711,13.719616,566921.994202629,1108971.81087692,579.390930175781,241,2.7629716924462,2.34048569740375 +-143.82456,59.5786316,13.719616,570625.944150638,1108971.80290764,413.738616943359,241,2.61672605834464,1.80927981168708 +-143.75955,59.57356,13.719616,574329.875952703,1108971.78767267,406.6904296875,341,2.6092639526288,1.78217531383013 +-143.69456,59.5684564,13.719616,578033.794574464,1108971.77558578,253.298049926758,241,2.40363184628755,1.03526081035217 +-143.62959,59.5633208,13.719616,581737.706672622,1108971.76602395,154.45231628418,141,2.18879442569603,0.254909978058931 +-143.56464,59.5581531,13.719616,585441.620648934,1108971.74733601,170.404968261719,141,2.23148225273816,0.409964350194836 +-143.49971,59.5529535,13.719616,589145.53966174,1108971.74102054,322.882354736328,241,2.50904431181792,1.4181489728716 +-143.43479,59.5477218,13.719616,592850.03025606,1108971.81368542,616.114868164062,341,2.78966168937074,2.43743138431725 +-143.3699,59.5424582,13.719616,596553.982752928,1108971.80887216,505.627166748047,341,2.70383040002869,2.12566764273789 +-143.30503,59.5371626,13.719616,600257.961937875,1108971.8037065,500.114044189453,440,2.69906905056515,2.10837306246186 +-143.24018,59.5318351,13.719616,603961.972634952,1108971.80869552,532.304870605469,440,2.72616043999842,2.2067767215359 +-143.17535,59.5264756,13.719616,607666.023249229,1108971.81228791,587.179931640625,440,2.76877120404924,2.36155117889139 +-143.11055,59.5210842,13.719616,611369.562181146,1108971.73296007,619.689270019531,440,2.79217397636325,2.44655672775212 +-142.26998,59.4480992,13.719616,659521.948017053,1108971.8036769,245.609039306641,241,2.39024434638099,0.986633589518627 +-142.20548,59.4422627,13.719616,663225.658497614,1108971.75729377,198.216033935547,141,2.29713878217793,0.648447605359319 +-142.14099,59.4363944,13.719616,666930.065950928,1108971.82239491,191.816268920898,141,2.28288543913774,0.596675395128218 +-142.07653,59.4304945,13.719616,670634.06007067,1108971.82042982,193.715744018555,141,2.28716491892519,0.612219687201374 +-142.0121,59.424563,13.719616,674337.647259088,1108971.74946632,191.756362915039,141,2.2827497837451,0.596182656022239 +-141.94768,59.4185998,13.719616,678041.948715676,1108971.80078514,190.673843383789,141,2.2802911206642,0.587252089940125 +-141.88329,59.4126051,13.719616,681745.854022138,1108971.79251661,188.247482299805,141,2.27472917647638,0.567049521113034 +-141.81892,59.4065787,13.719616,685449.930003752,1108971.80399343,189.212753295898,141,2.27695040531827,0.575117658268587 +-141.75458,59.4005207,13.719616,689153.624631129,1108971.74224296,182.07763671875,141,2.26025660781544,0.514481020854146 +-141.69025,59.3944312,13.719616,692858.055003622,1108971.82505447,185.080871582031,141,2.26736153601035,0.54028814800645 +-141.62596,59.3883101,13.719616,696561.560353952,1108971.72827868,187.11296081543,141,2.27210387096164,0.557513662146696 +-141.56168,59.3821575,13.719616,700265.814141608,1108971.77573225,183.918014526367,141,2.26462426989184,0.530345616170482 +-141.49743,59.3759734,13.719616,703969.709909404,1108971.75693839,204.252868652344,141,2.31016816474489,0.695774041798571 +-141.4332,59.3697578,13.719616,707673.81037144,1108971.7766519,277.61279296875,141,2.44343947542734,1.17985348161643 +-141.369,59.3635107,13.719616,711377.565451827,1108971.72763848,336.818908691406,240,2.52739646438886,1.48480922923511 +-141.30482,59.3572322,13.719616,715081.535729304,1108971.72677489,319.849395751953,340,2.50494553460074,1.40326104411132 +-141.24066,59.3509222,13.719616,718785.729612332,1108971.76299199,314.107482910156,340,2.49707828261907,1.37468493937661 +-141.17653,59.3445808,13.719616,722489.594862876,1108971.73839899,293.463439941406,240,2.46755400397987,1.26744433229092 +-141.11242,59.338208,13.719616,726193.694135603,1108971.76060594,244.046493530273,142,2.38747257207698,0.976565714103297 +-141.04833,59.3318037,13.719616,729898.035854033,1108971.8185935,162.012344360352,142,2.20954810641508,0.330293270120754 +-140.98427,59.3253682,13.719616,733602.063377043,1108971.834768,163.293167114258,142,2.21296801237501,0.342715344705564 +-140.92024,59.3189012,13.719616,737305.789450349,1108971.77452804,160.789093017578,142,2.20625658543895,0.318337526441822 +-140.85623,59.3124029,13.719616,741009.772341024,1108971.7697034,156.758743286133,142,2.19523177313928,0.278292261374695 +-140.79224,59.3058733,13.719616,744714.018251673,1108971.82029445,149.858123779297,142,2.17568029093792,0.207275697470752 +-140.72828,59.2993124,13.719616,748417.976986986,1108971.81362103,143.927520751953,142,2.15814384444349,0.143578318402841 +-140.66435,59.2927202,13.719616,752121.654738213,1108971.74803873,140.149444580078,142,2.14659138096691,0.101616473654514 +-140.60044,59.2860967,13.719616,755825.614083131,1108971.73572752,138.422058105469,142,2.14120530218839,0.0820526981910076 +-140.53655,59.279442,13.719616,759529.858950416,1108971.78769603,137.225311279297,142,2.13743422460015,0.068355068017799 +-140.47269,59.2727561,13.719616,763233.839090288,1108971.78908317,131,142,2.11727129565576,-0.0048824449810836 +-140.40886,59.2660389,13.719616,766937.562911607,1108971.72734723,130,142,2.11394335230684,-0.0169704851139895 +-140.34505,59.2592906,13.719616,770641.588403768,1108971.73884521,130,142,2.11394335230684,-0.0169704851139895 +-140.28126,59.252511,13.719616,774345.92624671,1108971.80179175,122,142,2.08635983067475,-0.117161708802643 +-140.2175,59.2457003,13.719616,778050.021591669,1108971.82103822,123.733703613281,142,2.09248801247935,-0.0949024033310957 +-140.15377,59.2388585,13.719616,781753.880520634,1108971.79503904,124.166519165039,142,2.09400450645178,-0.0893940643727526 +-140.09006,59.2319855,13.719616,785458.067826635,1108971.8295988,124.62801361084,142,2.09561567305479,-0.083541847397889 +-140.02638,59.2250815,13.719616,789162.02854893,1108971.82791689,119.326568603516,142,2.07673715207975,-0.152114024045585 +-139.96273,59.2181463,13.719616,792865.77341168,1108971.76661965,123.992324829102,142,2.09339480300472,-0.09160868131919 +-139.8991,59.2111801,13.719616,796569.86018494,1108971.78602693,133.616317749023,142,2.12585949912465,0.0263123613352157 +-139.8355,59.2041829,13.719616,800273.73849767,1108971.76582519,138.024383544922,142,2.13995581613721,0.0775142082143069 +-139.77192,59.1971546,13.719616,803977.973134362,1108971.81468079,133.017776489258,142,2.12390968393929,0.0192300760493515 +-139.70837,59.1900953,13.719616,807682.011356069,1108971.82212096,132.517288208008,142,2.12227254003555,0.0132835021035474 +-139.64485,59.183005,13.719616,811385.859166178,1108971.78670278,136.035736083984,142,2.13365301090977,0.054620620628524 +-139.58136,59.1758838,13.719616,815089.520153823,1108971.71791432,135.036636352539,142,2.1304516115111,0.0429922242421978 +-139.51789,59.1687316,13.719616,818793.559090083,1108971.7267093,128.37287902832,142,2.10847328126819,-0.0368393444400774 +-139.45444,59.1615484,13.719616,822497.981960363,1108971.81335843,114.229095458984,142,2.0577767377792,-0.220983660626228 +-139.39103,59.1543344,13.719616,826201.677080485,1108971.75115207,108.29337310791,142,2.03460188127238,-0.305161354221607 +-139.32764,59.1470894,13.719616,829905.768045652,1108971.76514106,98.0343856811523,40,1.99137843173638,-0.462161260137112 +-139.26428,59.1398136,13.719616,833609.699510216,1108971.75192471,91.269775390625,40,1.96032698175911,-0.574948989420768 +-139.20094,59.1325069,13.719616,837314.036235908,1108971.82531686,84.4986953735352,40,1.92685000366628,-0.696546929134793 +-139.13764,59.1251694,13.719616,841017.66888102,1108971.74327201,76.8226623535156,40,1.8854893539279,-0.846780614489362 +-139.07436,59.1178011,13.719616,844721.716116664,1108971.7571718,71.2455215454102,40,1.85275757002449,-0.965671796207805 +-139.01111,59.110402,13.719616,848425.627431119,1108971.7396118,66.7173309326172,40,1.82423866376244,-1.06926060385782 +-138.94788,59.1029721,13.719616,852129.965091034,1108971.81759254,67.2065963745117,40,1.82741190145348,-1.05773449883175 +-138.88469,59.0955114,13.719616,855833.622180174,1108971.73375103,69.3349685668945,40,1.84095232300085,-1.00855182295061 +-138.82152,59.08802,13.719616,859537.714812212,1108971.75487179,74.4308319091797,40,1.87175287310375,-0.896675433624637 +-138.75838,59.0804979,13.719616,863241.692419776,1108971.75136418,94.5549468994141,40,1.97568425507336,-0.519166989341206 +-138.69527,59.0729451,13.719616,866945.560821573,1108971.72196189,104.270751953125,40,2.01816250548601,-0.364873859342707 +-138.63218,59.0653616,13.719616,870649.882222368,1108971.79651162,101.459732055664,142,2.00629371105747,-0.407984708398349 +-138.56913,59.0577475,13.719616,874353.547069738,1108971.72300909,93.6016082763672,40,1.9712833109128,-0.535152474686898 +-138.5061,59.0501027,13.719616,878057.67650185,1108971.75210069,88.2320022583008,40,1.94562613482987,-0.628346661507242 +-138.4431,59.0424273,13.719616,881761.717325442,1108971.76234508,74.5800018310547,40,1.87262238968789,-0.893517101206293 +-138.38013,59.0347213,13.719616,885465.675297169,1108971.75253243,53.3670234680176,40,1.72727298081625,-1.42146764107975 +-138.31719,59.0269847,13.719616,889169.556167439,1108971.72146557,47.534984588623,40,1.67701335744285,-1.60402493869668 +-138.25427,59.0192175,13.67261674,892873.92207262,1108971.80240649,31.0120277404785,40,1.49153016377713,-2.27775284026485 +-152.59983,59.9298451,13.719616,77994.022280014,1105267.78396258,17.777904510498,32,1.24988056916738,-3.15549314154869 +-152.46689,59.9283823,13.719616,85401.7302600075,1105267.7760273,27.4967651367188,32,1.43928160416087,-2.46753452201479 +-152.40042,59.9276012,13.719616,89105.8371706428,1105267.77921122,43.9042167663574,32,1.64250623391897,-1.72936466064904 +-152.33396,59.9267869,13.719616,92809.5658096417,1105267.7663149,81.9850769042969,32,1.91373480838463,-0.744185061847167 +-152.26749,59.9259396,13.719616,96514.0369230923,1105267.78754865,68.6004943847656,32,1.83632724555809,-1.02535142435125 +-152.20104,59.925059,13.719616,100217.587931309,1105267.76625257,92.2634658813477,32,1.96502976487091,-0.557867138850789 +-152.13458,59.9241454,13.719616,103921.896203354,1105267.7800588,55.2159423828125,32,1.74206448876646,-1.3677406622879 +-152.06813,59.9231986,13.719616,107625.855849568,1105267.77638459,42.7568054199219,32,1.6310052493822,-1.77113951919438 +-152.00168,59.9222187,13.719616,111330.030909413,1105267.78203225,30.7821197509766,32,1.48829852337245,-2.28949108061665 +-151.93524,59.9212057,13.719616,115033.8718243,1105267.78023149,31.7783432006836,32,1.50213125103507,-2.23924666549248 +-151.8688,59.9201595,13.719616,118737.943293403,1105267.77658064,22.264404296875,32,1.34761107970344,-2.80050803221681 +-151.80237,59.9190803,13.70182703,122441.695049609,1105267.77558638,18.8799953460693,32,1.2760018829082,-3.06061307427679 +-149.67951,59.8670818,11.5853918,240969.73811612,1105267.77545579,81.9469833374023,33,1.91353297079201,-0.744918193593742 +-149.54708,59.8627093,12.76894522,248377.704618747,1105267.76627005,71.1419143676758,33,1.85212554749766,-0.967967482422418 +-149.48088,59.8604737,13.719616,252081.588828929,1105267.76312904,262.956604003906,33,2.41988408234263,1.09429357055421 +-149.41468,59.8582051,11.33631191,255785.974417269,1105267.78773986,220.632308959961,33,2.34366910998811,0.8174590370437 +-149.3485,59.8559036,12.14685097,259489.753994766,1105267.7743783,85.3816299438477,33,1.93136444127212,-0.680149203201586 +-149.28232,59.8535691,13.32697697,263194.049513073,1105267.7890877,90.5516891479492,33,1.95689655603927,-0.587409274776216 +-149.21616,59.8512018,13.719616,266897.752751459,1105267.77510154,125.933258056641,133,2.1001404392664,-0.0671066050204698 +-149.15,59.8488015,13.719616,270601.986461745,1105267.7895763,207.597137451172,133,2.31722136074804,0.721393262864581 +-149.08386,59.8463683,13.719616,274305.643201074,1105267.76239507,213.830596923828,133,2.33006984832105,0.768062637053203 +-149.01772,59.8439022,13.719616,278009.844117837,1105267.77529014,139.241958618164,133,2.14377012356857,0.0913688615167332 +-148.95159,59.8414033,13.719616,281714.038658741,1105267.7983653,110.691772460938,133,2.04411534167723,-0.270605750619245 +-148.88548,59.8388714,13.719616,285417.678804753,1105267.7660585,157.40348815918,133,2.19701435236547,0.284767097923006 +-148.81937,59.8363067,13.719616,289121.883987131,1105267.78580298,183.737838745117,133,2.2641986035893,0.528799474662415 +-148.75328,59.8337091,13.719616,292825.548393603,1105267.759689,172.393280029297,133,2.23652033281656,0.428264095050814 +-148.68719,59.8310786,13.719616,296529.793159958,1105267.77511619,132.185607910156,133,2.12118417265752,0.00933024113559399 +-148.62111,59.8284153,13.719616,300234.067664654,1105267.79948514,131.963150024414,133,2.12045267381702,0.00667322855634026 +-148.55505,59.8257191,13.719616,303937.823070843,1105267.77568902,138.526473999023,133,2.14153277999228,0.0832421910462176 +-148.489,59.8229901,13.719616,307641.622629448,1105267.75934825,99.4078598022461,133,1.99742072377152,-0.440213930823655 +-148.42295,59.8202283,13.719616,311346.030482369,1105267.79718486,146.309707641602,33,2.16527314249791,0.169473963840751 +-148.35692,59.8174336,13.719616,315049.940867897,1105267.78470909,127.755744934082,133,2.10638043864685,-0.0444411461975451 +-148.2909,59.8146062,13.719616,318753.916035331,1105267.79040691,97.7160263061523,133,1.98996579775699,-0.467292349956151 +-148.22489,59.8117459,13.719616,322457.96507753,1105267.79188813,122.931449890137,33,2.08966300385022,-0.105163641009857 +-148.1589,59.8088528,13.719616,326161.537276198,1105267.7510944,143.026382446289,133,2.15541615420658,0.133670568902063 +-148.09291,59.805927,13.719616,329865.752715844,1105267.77676121,118.238754272461,133,2.07275984548033,-0.166560736851001 +-148.02693,59.8029683,13.719616,333570.063597185,1105267.79800272,47.0206909179688,33,1.67228900632139,-1.62118513043387 +-147.96097,59.7999769,13.719616,337273.918144535,1105267.7862743,16.5220394134521,33,1.21806365384044,-3.2710612594679 +-147.76316,59.7908061,9.248305881,348385.604071944,1105267.75418283,15.7812118530273,33,1.19814035000614,-3.34342838567115 +-147.69724,59.7876837,13.21686781,352089.934576644,1105267.78641014,43.5041275024414,33,1.63853046308099,-1.74380579513054 +-147.63134,59.7845286,13.719616,355793.844441318,1105267.78184202,55.737964630127,33,1.74615110563951,-1.3528969033684 +-147.56545,59.7813407,13.719616,359497.89881852,1105267.78187495,64.2475280761719,33,1.80785642284333,-1.12876557883312 +-147.49958,59.7781202,13.719616,363201.545723354,1105267.75416591,67.9020462036133,33,1.8318828617849,-1.04149469476892 +-147.43371,59.7748669,13.719616,366905.908344903,1105267.78538045,90.3616790771484,33,1.95598429227007,-0.590722877171934 +-147.36786,59.771581,13.719616,370609.877697778,1105267.78795859,94.2373733520508,33,1.97422317266153,-0.524474057695396 +-147.30202,59.7682623,13.719616,374314.020058805,1105267.79447311,96.1044006347656,140,1.98274327453263,-0.493526615820389 +-147.2362,59.764911,13.719616,378017.783341971,1105267.77041129,120.930862426758,140,2.08253715008471,-0.131046775807342 +-147.17039,59.7615271,13.719616,381721.731565708,1105267.77174805,205.932632446289,140,2.31372517113686,0.70869410428492 +-147.10459,59.7581105,13.719616,385425.872954173,1105267.78754777,215.212829589844,140,2.33286815757982,0.77822689499805 +-147.03881,59.7546612,13.719616,389129.657652251,1105267.75942401,195.775634765625,140,2.29175864075985,0.628905396083614 +-146.97304,59.7511793,13.719616,392833.648520393,1105267.75620064,135.324417114258,140,2.13137616512126,0.0463504668481636 +-146.90728,59.7476648,13.719616,396537.85261365,1105267.77811663,92.437614440918,41,1.96584872901267,-0.554892427332246 +-146.84154,59.7441177,13.719616,400241.720033666,1105267.7651609,95.1160736083984,41,1.97825391430406,-0.509833253561536 +-146.77581,59.740538,13.719616,403945.814778611,1105267.7767589,88.5834121704102,41,1.94735240498734,-0.622076355568733 +-146.7101,59.7369257,13.719616,407649.58694319,1105267.75181869,84.7926254272461,41,1.92835808249818,-0.691069156368755 +-146.6444,59.7332808,13.719616,411353.600518575,1105267.75091571,80.4499893188477,41,1.90552599077481,-0.774001830435825 +-146.57871,59.7296034,13.719616,415057.861295368,1105267.78548814,83.2491760253906,41,1.9203799436871,-0.720048033718133 +-146.51304,59.7258934,13.719616,418761.820582705,1105267.78170722,81.7699813842773,41,1.9125938988808,-0.748329170813059 +-146.44738,59.7221508,13.719616,422466.042361019,1105267.80187331,83.6655502319336,41,1.92254667156601,-0.712177859616233 +-146.38174,59.7183757,13.719616,426169.97542719,1105267.79330082,89.1122055053711,41,1.94993719248352,-0.612687669610798 +-146.31612,59.7145681,13.719616,429873.626771442,1105267.75470682,81.8403854370117,41,1.91296766607034,-0.746971541696862 +-146.25051,59.710728,13.719616,433577.560330313,1105267.75011241,83.9972305297852,41,1.92426496718736,-0.7059365194691 +-146.18491,59.7068554,13.719616,437281.783086645,1105267.77994202,77.0568542480469,41,1.88681127549711,-0.841979018035986 +-146.11933,59.7029502,13.719616,440985.746393419,1105267.76713085,79.5317611694336,41,1.90054059967516,-0.79211019388205 +-146.05376,59.6990126,13.719616,444690.011539209,1105267.79963327,74.8420944213867,41,1.87414593252818,-0.887983158747941 +-145.98821,59.6950425,13.719616,448394.029858466,1105267.79930169,73.7865982055664,41,1.86797748846385,-0.910388708238816 +-145.92268,59.69104,13.719616,452097.806962185,1105267.77605514,75.0151062011719,41,1.87514872844772,-0.884340717741734 +-145.85716,59.687005,13.719616,455801.908099023,1105267.78626077,79.3670272827148,41,1.89964011397212,-0.7953810149797 +-145.79166,59.6829376,13.719616,459505.781900362,1105267.77235078,82.4420928955078,41,1.91614900835503,-0.735415998473401 +-145.72617,59.6788378,13.719616,463209.992239424,1105267.80293996,87.5914306640625,140,1.94246161989692,-0.639841082986198 +-145.6607,59.6747055,13.719616,466913.990486025,1105267.79718334,91.1942291259766,140,1.95996735655164,-0.57625525082155 +-145.59525,59.6705409,13.719616,470617.78076548,1105267.77617041,104.080955505371,140,2.01737127057126,-0.367747850394001 +-145.52981,59.6663438,13.719616,474321.929751041,1105267.7880525,109.683006286621,140,2.04013934546305,-0.285047703731432 +-145.46439,59.6621144,13.719616,478025.884566311,1105267.7836404,108.653060913086,140,2.03604196552942,-0.299930557159063 +-145.39899,59.6578527,13.719616,481729.652081838,1105267.76187972,110.550735473633,140,2.04356163620535,-0.272616966936384 +-145.3336,59.6535585,13.719616,485433.799024302,1105267.77265368,110.904136657715,140,2.04494774537471,-0.267582222798309 +-145.26823,59.6492321,13.719616,489137.770973556,1105267.77622719,113.866516113281,140,2.05639603307704,-0.225998774196837 +-145.20288,59.6448733,13.719616,492841.577709004,1105267.74942294,121.361404418945,140,2.08408059355215,-0.125440548590963 +-145.13754,59.6404822,13.719616,496545.781579668,1105267.77710879,184.252838134766,140,2.26541418622864,0.533214817770326 +-145.07222,59.6360588,13.719616,500249.832485541,1105267.78466044,161.038925170898,140,2.20693086325972,0.320786695944927 +-145.00692,59.6316031,13.719616,503953.737272401,1105267.77112317,163.750991821289,140,2.21418393914448,0.347131937792336 +-144.94163,59.6271151,13.719616,507658.059731787,1105267.81200059,160.721908569336,140,2.20607508100879,0.317678250544972 +-144.87637,59.6225949,13.719616,511361.691269645,1105267.765122,164.233016967773,140,2.21546047096534,0.351768665724142 +-144.81112,59.6180424,13.719616,515065.754128581,1105267.77194366,183.960678100586,241,2.26472500176523,0.530711503086379 +-144.74589,59.6134577,13.719616,518769.696634182,1105267.76620877,136.547958374023,140,2.13528521107755,0.0605492375142058 +-144.68068,59.6088407,13.719616,522473.527142218,1105267.73596826,142.479095458984,140,2.15375114930739,0.127622795868477 +-144.61548,59.6041916,13.719616,526177.806272934,1105267.78173777,142.746215820312,140,2.15456460399221,0.130577495466837 +-144.5503,59.5995102,13.719616,529881.986998259,1105267.8024154,145.410766601562,140,2.16259656403702,0.159751866899237 +-144.48515,59.5947967,13.719616,533585.515986234,1105267.73896684,154.902694702148,141,2.19005897285342,0.259503174272273 +-144.42001,59.590051,13.719616,537289.515485904,1105267.73964396,227.214736938477,241,2.35643649589242,0.863833826822902 +-144.35488,59.5852731,13.719616,540993.992267012,1105267.80532455,459.281524658203,341,2.66207897557169,1.97401455206708 +-144.28978,59.5804631,13.719616,544697.83756572,1105267.78392697,598.120910644531,440,2.77678898585766,2.39067405092235 +-144.2247,59.5756209,13.719616,548401.616700201,1105267.74452608,622.119018554688,440,2.79387347819061,2.45272980347521 +-143.70472,59.5357288,13.719616,578033.538195222,1105267.73644183,584.681945800781,341,2.76691968360956,2.35482592817792 +-143.63981,59.5305981,13.719616,581737.559183829,1105267.73779832,279.448669433594,241,2.44630204610786,1.1902511553871 +-143.57492,59.5254354,13.719616,585441.577584534,1105267.73756631,267.377746582031,241,2.42712525880181,1.1205955902915 +-143.51005,59.5202408,13.719616,589145.598283142,1105267.74619113,502.500213623047,341,2.70113625071997,2.11588172346184 +-143.38037,59.5097556,13.719616,596553.678340651,1105267.75456395,628.394958496094,440,2.79823269211251,2.46856371268308 +-143.31556,59.5044651,13.719616,600257.749173636,1105267.76423372,634.465454101562,440,2.80240798025026,2.48372955094526 +-142.28149,59.4154872,13.719616,659521.624564476,1105267.74632431,457.325988769531,341,2.66022588202466,1.96728358737872 +-142.21704,59.4096562,13.719616,663225.926275609,1105267.79642347,233.623611450195,241,2.36851673315068,0.907712696587881 +-142.15262,59.4037936,13.719616,666929.804756216,1105267.77661781,223.748687744141,241,2.34976049691689,0.839584693023954 +-142.08822,59.3978994,13.719616,670633.823361698,1105267.78593597,207.554077148438,141,2.31713126898737,0.721066023875079 +-142.02384,59.3919735,13.719616,674337.990497617,1105267.81311277,206.520874023438,141,2.31496395437031,0.713193718572722 +-141.95949,59.386016,13.719616,678041.753624753,1105267.76680371,199.968460083008,141,2.3009615022036,0.662332815605475 +-141.89516,59.380027,13.719616,681745.674055915,1105267.75875124,194.814880371094,141,2.28962212613726,0.621144965152376 +-141.83085,59.3740063,13.719616,685449.762218085,1105267.76674114,189.430801391602,141,2.27745059656171,0.576934495633583 +-141.76656,59.3679542,13.719616,689154.018378058,1105267.82354889,188.509796142578,141,2.27533392377322,0.569246135907217 +-141.7023,59.3618704,13.719616,692857.898071373,1105267.79167343,189.884521484375,141,2.27848956448478,0.580708323681138 +-141.63806,59.3557552,13.719616,696561.958440226,1105267.80712096,193.611953735352,141,2.28693216744054,0.611374267375235 +-141.57385,59.3496085,13.719616,700265.650913394,1105267.75328794,200.304809570312,141,2.3016913773753,0.664983930556226 +-141.50966,59.3434302,13.719616,703969.540856668,1105267.72336647,233.43473815918,141,2.36816548524939,0.906436863954291 +-141.44549,59.3372205,13.719616,707673.630419598,1105267.7391876,322.494689941406,240,2.50852256812437,1.41625385085614 +-141.38134,59.3309794,13.719616,711377.925884769,1105267.80062151,329.251617431641,340,2.51752791708837,1.44896384867591 +-141.31722,59.3247068,13.719616,715081.878701575,1105267.78890034,325.157745361328,340,2.51209410350037,1.42922668675949 +-141.25312,59.3184028,13.719616,718786.049990521,1105267.82146455,321.073608398438,340,2.50660460890509,1.40928727553166 +-141.18905,59.3120674,13.719616,722489.8890677,1105267.78943723,282.790924072266,240,2.45146546704642,1.209006174023 +-141.125,59.3057007,13.719616,726193.956989611,1105267.81139283,230.894790649414,142,2.36341413465934,0.889178602440727 +-141.06098,59.2993025,13.719616,729897.707358686,1105267.75542341,177.726211547852,142,2.24975148346718,0.476323410760236 +-140.99698,59.292873,13.719616,733601.699055682,1105267.75221672,164.510650634766,142,2.21619401998917,0.354433125154452 +-140.933,59.2864122,13.719616,737305.938292665,1105267.80173767,159.418258666992,142,2.20253806100113,0.304830784311121 +-140.86905,59.2799201,13.719616,741009.874326112,1105267.79238616,156.669845581055,142,2.19498541537119,0.277397419643481 +-140.80513,59.2733967,13.719616,744713.513356842,1105267.72248243,150.524887084961,142,2.17760831009678,0.214278813367185 +-140.74122,59.266842,13.719616,748417.975479994,1105267.81575037,146.674835205078,142,2.16635560894178,0.173405790931569 +-140.67735,59.260256,13.719616,752121.5960351,1105267.73412758,144.303558349609,142,2.15927704039735,0.147694409553571 +-140.61349,59.2536388,13.719616,755826.049817485,1105267.82668825,143.638717651367,142,2.15727151926508,0.140409784368459 +-140.54967,59.2469904,13.719616,759529.672123691,1105267.75204521,130,142,2.11394335230684,-0.0169704851139895 +-140.48587,59.2403108,13.719616,763233.582994445,1105267.73676103,132,142,2.12057393120585,0.00711367000286348 +-140.42209,59.2335999,13.719616,766937.790834717,1105267.76995987,128,142,2.10720996964787,-0.0414280528301153 +-140.35834,59.226858,13.719616,770641.738013969,1105267.76852821,131,142,2.11727129565576,-0.0048824449810836 +-140.29461,59.2200848,13.719616,774345.994415463,1105267.81464914,125,142,2.09691001300806,-0.0788404352462293 +-140.23091,59.2132806,13.719616,778050.0023341,1105267.82410813,121,142,2.08278537031645,-0.130145169076543 +-140.16724,59.2064452,13.719616,781753.772442613,1105267.77346886,120,142,2.07918124604762,-0.143236377140402 +-140.10359,59.1995787,13.719616,785457.865474598,1105267.79040754,124.551551818848,142,2.0953491428895,-0.0845099610335174 +-140.03997,59.1926812,13.719616,789161.728215941,1105267.76717629,123.309455871582,142,2.09099638134341,-0.10032043337074 +-139.97637,59.1857525,13.719616,792865.928334681,1105267.79978127,119.187881469727,142,2.07623210038427,-0.153948515959692 +-139.9128,59.1787929,13.719616,796569.907907886,1105267.80124751,112.186187744141,142,2.04993939029129,-0.249451143704002 +-139.84926,59.1718022,13.719616,800273.677652303,1105267.74822314,116.14234161377,142,2.06499057785097,-0.194780934450591 +-139.78574,59.1647806,13.719616,803977.795813744,1105267.78214808,118.595413208008,142,2.07406789259508,-0.161809536376416 +-139.72225,59.1577279,13.719616,807681.716188936,1105267.75976143,122.613609313965,142,2.08853867672346,-0.109247518049143 +-139.65878,59.1506443,13.719616,811385.996970056,1105267.82363644,126.233551025391,142,2.10117479935055,-0.0633495139590733 +-139.59535,59.1435297,13.719616,815089.532627743,1105267.71761672,124.777809143066,142,2.09613735599037,-0.0816469460727342 +-139.53193,59.1363842,13.719616,818793.997585562,1105267.81939657,122.154525756836,142,2.08690956197511,-0.115164927810807 +-139.46855,59.1292078,13.719616,822497.726946287,1105267.75935693,115.609893798828,142,2.06299500223651,-0.2020294346763 +-139.40519,59.1220005,13.719616,826201.840556605,1105267.78323555,108.939392089844,142,2.03718494746765,-0.295778920519872 +-139.34186,59.1147624,13.719616,829905.784959686,1105267.77725877,101.306167602539,142,2.00563588636928,-0.410374115427736 +-139.27856,59.1074934,13.719616,833609.568516966,1105267.72913648,96.8283920288086,40,1.98600271984444,-0.481687380109568 +-139.21528,59.1001935,13.719616,837313.754107038,1105267.76358542,91.4300155639648,40,1.96108879369706,-0.572181871019358 +-139.15203,59.0928629,13.719616,841017.785745053,1105267.77609246,86.9114532470703,40,1.93907701182547,-0.652134945565023 +-139.08881,59.0855014,13.719616,844721.674263344,1105267.74350824,85.5418930053711,40,1.93217885677759,-0.67719101362841 +-139.02561,59.0781092,13.719616,848425.977523367,1105267.81405497,83.7245178222656,40,1.92285265507446,-0.711066440177144 +-138.96245,59.0706863,13.719616,852129.587467203,1105267.73145732,79.2079696655273,40,1.89876888118076,-0.798545581152515 +-138.89931,59.0632326,13.719616,855833.626350881,1105267.73957623,80.2372055053711,40,1.90437579470415,-0.778179670863124 +-138.8362,59.0557482,13.719616,859537.540554801,1105267.72025471,96.4526443481445,40,1.98431413877166,-0.48782078853495 +-138.77311,59.0482331,13.719616,863241.892852622,1105267.8021906,129.655502319336,142,2.11279095208276,-0.021156331655595 +-138.71006,59.0406873,13.719616,866945.575161876,1105267.72469846,140.765930175781,142,2.14849755447154,0.108540239899437 +-138.64703,59.0331109,13.719616,870649.704632425,1105267.75792596,136.55810546875,142,2.13531748298823,0.0606664583051119 +-138.58403,59.0255038,13.719616,874353.732660212,1105267.75975361,124.796081542969,142,2.09620094920071,-0.0814159573814688 +-138.52106,59.0178661,13.719616,878057.662462102,1105267.73982269,103.112800598145,142,2.01331258268467,-0.382490163262953 +-138.45811,59.0101979,13.719616,881762.054157504,1105267.84055056,77.3137588500977,40,1.88825678836786,-0.836728502698981 +-138.3952,59.002499,13.719616,885465.804776399,1105267.77397983,62.966609954834,40,1.79911031204843,-1.16053394962874 +-138.33231,58.9947697,13.719616,889170.026160168,1105267.83762517,60.1969871520996,40,1.77957475544451,-1.23149266721718 +-138.26946,58.9870097,13.719616,892873.6179598,1105267.73045926,51.2000007629395,40,1.70926996744732,-1.48685972420729 +-138.20663,58.9792193,13.719616,896577.691942461,1105267.75223775,44.601692199707,40,1.64935133626939,-1.70450129512556 +-138.14383,58.9713984,12.61589322,900281.699470765,1105267.75702783,20.5671215057373,40,1.31317351378267,-2.92559510110097 +-152.60123,59.8967313,13.719616,77994.0410525699,1101563.78002995,13.1200256347656,32,1.11793468359348,-3.6347582590583 +-152.53483,59.8960172,13.719616,81697.6144310442,1101563.77230451,21.8600406646729,32,1.33965096550145,-2.82942143904123 +-152.46842,59.89527,13.719616,85401.9086576823,1101563.78157843,43.1565170288086,32,1.6350463874426,-1.75646095230336 +-152.40202,59.8944896,13.719616,89105.8163799027,1101563.77193043,56.3222503662109,32,1.75067999879923,-1.33644667073746 +-152.33562,59.8936762,13.719616,92809.9019714885,1101563.77846104,100.587364196777,32,2.00254342799347,-0.421606806924172 +-152.26923,59.8928297,13.719616,96513.6155748072,1101563.77591447,79.8838806152344,32,1.90245915395589,-0.785141457124548 +-152.20284,59.89195,13.719616,100217.522391524,1101563.76700476,80.6198577880859,32,1.9064420277304,-0.770674522750147 +-152.13645,59.8910373,13.719616,103921.629218104,1101563.77458459,46.3718299865723,32,1.66625423493804,-1.64310514259345 +-152.07006,59.8900914,13.719616,107625.944060461,1101563.77680912,42.246997833252,32,1.6257958524389,-1.79006153580237 +-152.00368,59.8891125,13.719616,111329.916160773,1101563.77980316,37.4460678100586,32,1.57340621941722,-1.98035563642712 +-151.93731,59.8881005,13.719616,115033.553220433,1101563.77126478,27.4925842285156,32,1.43921556426818,-2.46777439775468 +-151.87093,59.8870554,13.719616,118737.977641493,1101563.78584772,18.2216644287109,32,1.26058804438175,-3.11660053535237 +-149.81615,59.8382664,6.81529277,233561.945105542,1101563.78029294,139.54264831543,33,2.14470696099559,0.0947717224516934 +-149.68382,59.83403,11.18129764,240969.744714877,1101563.76960893,189.809417724609,33,2.27831775690245,0.580084269503322 +-149.61767,59.8318624,6.105831696,244673.522095955,1101563.75527227,14.8575677871704,33,1.17194772038923,-3.43856749256055 +-149.55152,59.8296619,13.719616,248377.784819568,1101563.77543236,101.342636108398,33,2.0057921969,-0.409806350964692 +-149.48538,59.8274285,13.719616,252081.982639179,1101563.79335691,272.91650390625,33,2.43602979927814,1.15293942291042 +-149.41926,59.8251621,13.67758291,255785.566076753,1101563.75894442,229.815856933594,33,2.36137999102404,0.881790012154917 +-149.35314,59.8228629,13.45874871,259489.655874074,1101563.77057007,158.517227172852,33,2.20007646692949,0.295889572034013 +-149.28703,59.8205307,13.719616,263193.703330395,1101563.76757076,102.34351348877,133,2.01006032237415,-0.394303300998264 +-149.22093,59.8181657,13.719616,266897.714123009,1101563.77188128,111.667106628418,133,2.04792526341495,-0.2567670274079 +-149.15484,59.8157678,13.719616,270601.696283486,1101563.77198873,194.965515136719,133,2.28995780156632,0.622364234122028 +-149.08876,59.813337,13.719616,274305.657059161,1101563.76755368,200.242965698242,133,2.30155726876579,0.664496809808054 +-149.02269,59.8108733,13.719616,278009.603694951,1101563.75825477,203.300827026367,133,2.3081391453486,0.688404064211445 +-148.95663,59.8083768,13.719616,281713.54258489,1101563.75493921,164.005630493164,133,2.2148587581095,0.349583072885805 +-148.89057,59.8058475,13.719616,285418.038443403,1101563.80029646,184.055648803711,133,2.26494915080542,0.53152567637886 +-148.82453,59.8032852,13.719616,289121.985200459,1101563.78636153,190.642715454102,133,2.28022021533469,0.586994541544942 +-148.7585,59.8006902,13.719616,292825.944986886,1101563.78875123,176.201370239258,133,2.24600928140313,0.462730664732789 +-148.69248,59.7980623,13.719616,296529.926754062,1101563.78493443,157.458419799805,133,2.19716588869327,0.285317521118333 +-148.62647,59.7954016,13.719616,300233.936827863,1101563.78584361,158.027526855469,133,2.19873274341121,0.291008784678752 +-148.56047,59.7927081,13.719616,303937.982402139,1101563.79128025,157.930770874023,133,2.19846675520676,0.290042639599614 +-148.49449,59.7899818,13.719616,307641.513160353,1101563.75473978,158.468307495117,133,2.19994241951128,0.295402673550153 +-148.42851,59.7872227,13.719616,311345.651306437,1101563.76814931,138.150634765625,133,2.14035288472538,0.0789564746612029 +-148.36254,59.7844308,13.719616,315049.846518423,1101563.78559765,127.349922180176,133,2.10499868391502,-0.049460073775605 +-148.29659,59.7816061,13.719616,318753.548471586,1101563.75896043,119.744903564453,133,2.07825703857148,-0.146593362488836 +-148.23064,59.7787486,13.719616,322457.879361577,1101563.78356455,150.913635253906,133,2.17872848065038,0.218347592546357 +-148.16471,59.7758584,13.719616,326161.730369007,1101563.77390593,113.463844299316,133,2.05485749392722,-0.231587187531762 +-148.09879,59.7729354,13.719616,329865.667135327,1101563.7667661,65.2634963989258,33,1.81467033678383,-1.10401549851656 +-148.03288,59.7699796,13.719616,333569.696832178,1101563.76208875,30.9964904785156,33,1.49131252441179,-2.27854336856024 +-147.96698,59.7669912,13.719616,337273.824599321,1101563.78210843,30.5627326965332,33,1.48519218308318,-2.3007741951851 +-147.90109,59.76397,10.22000109,340978.059587288,1101563.804527,17.4561576843262,33,1.24194865631504,-3.1843041130217 +-147.83522,59.760916,11.36570301,344681.851451164,1101563.77743989,38.8441047668457,33,1.58932511679202,-1.92253365745619 +-147.76936,59.7578294,13.719616,348385.762763224,1101563.77391424,62.6646957397461,33,1.79702293535019,-1.16811589759339 +-147.70351,59.75471,13.719616,352089.802731275,1101563.7717109,76.0188217163086,33,1.88092113380075,-0.863373693891012 +-147.63767,59.751558,13.719616,355793.976369622,1101563.79314218,86.1670227050781,33,1.93534108720002,-0.665704890143695 +-147.57185,59.7483733,13.719616,359497.734335633,1101563.77300632,87.1447067260742,33,1.94024101267983,-0.647906962223073 +-147.50604,59.7451559,13.719616,363201.641251376,1101563.76440155,94.8994140625,33,1.97726353097093,-0.513430608511002 +-147.44024,59.7419058,13.719616,366905.704228051,1101563.76742686,111.348091125488,33,2.04668277619024,-0.261280095649235 +-147.37445,59.7386231,13.719616,370609.92925987,1101563.79332574,105.389846801758,33,2.02279877320701,-0.348033611657455 +-147.30868,59.7353077,13.719616,374313.767035655,1101563.77473977,94.0146331787109,140,1.97319545587801,-0.528207018392718 +-147.24292,59.7319597,13.719616,378017.781028855,1101563.77819279,113.553291320801,140,2.0551997266821,-0.230344100483102 +-147.17717,59.728579,13.719616,381721.979451532,1101563.79272667,210.827560424805,140,2.32392738338127,0.745751451157875 +-147.11144,59.7251658,13.719616,385425.809575247,1101563.78273608,200.301406860352,140,2.30168399966573,0.664957132609237 +-147.04572,59.7217199,13.719616,389129.838271004,1101563.78309614,202.998733520508,140,2.30749332842173,0.686058272798558 +-146.98002,59.7182414,13.719616,392833.513939495,1101563.74599608,164.587982177734,140,2.21639812088573,0.355174477866946 +-146.91432,59.7147303,13.719616,396537.958648033,1101563.78941667,100.986015319824,41,2.00426123625845,-0.415367236994455 +-146.84864,59.7111867,13.719616,400242.063227779,1101563.8058663,95.343376159668,41,1.97929052646194,-0.506067982325549 +-146.78298,59.7076105,13.719616,403945.835903593,1101563.78282098,92.2495346069336,41,1.96496418384844,-0.558105347843083 +-146.71733,59.7040017,13.719616,407649.841224725,1101563.78027698,86.8346939086914,41,1.93869327774207,-0.653528777284535 +-146.6517,59.7003604,13.719616,411353.527486677,1101563.7477116,84.7993316650391,41,1.92839242943443,-0.690944398492705 +-146.58607,59.6966865,13.719616,415058.017952215,1101563.79765276,88.3154678344727,41,1.94603677387037,-0.626855103304088 +-146.52047,59.6929801,13.719616,418761.645872338,1101563.75405536,89.0098114013672,41,1.94943788083167,-0.614501312048069 +-146.45488,59.6892412,13.719616,422465.533256891,1101563.74115216,88.0885238647461,41,1.94491933239776,-0.63091396968214 +-146.3893,59.6854698,13.719616,426169.687096669,1101563.75931187,86.6587524414062,41,1.93781243254381,-0.656728258462881 +-146.32374,59.6816659,13.719616,429873.556871096,1101563.74419106,81.4994964599609,41,1.91115492548432,-0.753555932912975 +-146.25819,59.6778296,13.719616,433577.705770754,1101563.77091281,83.7476272583008,41,1.92297251143158,-0.710631087677698 +-146.19266,59.6739607,13.719616,437281.585857984,1101563.75183809,85.874755859375,41,1.93386551537675,-0.67106458817594 +-146.12714,59.6700594,13.719616,440985.759004361,1101563.77434462,89.0366897583008,41,1.94956900525267,-0.614025030724372 +-146.06164,59.6661256,13.719616,444689.675975079,1101563.76081965,87.5345687866211,41,1.94217959666166,-0.640865471874094 +-145.99615,59.6621594,13.719616,448393.899901936,1101563.78867992,80.5082778930664,41,1.90584053699461,-0.772859308785115 +-145.93068,59.6581608,13.719616,452097.880209059,1101563.79033355,88.9993591308594,41,1.949386879376,-0.614686563892337 +-145.86523,59.6541297,13.719616,455801.625190782,1101563.75350947,87.8278274536133,41,1.94363213999251,-0.635589419899302 +-145.79979,59.6500663,13.719616,459505.696557314,1101563.76844144,97.1886215209961,41,1.98761542233466,-0.47582958435399 +-145.73437,59.6459704,13.719616,463209.546464738,1101563.74371936,106.906272888184,140,2.02900318884579,-0.325497403140892 +-145.66896,59.6418422,13.719616,466913.736571732,1101563.77072059,106.562171936035,140,2.02760306364888,-0.330583057491573 +-145.60357,59.6376816,13.719616,470617.717660209,1101563.76805162,108.119522094727,140,2.03390411738109,-0.307695831836401 +-145.53819,59.6334886,13.719616,474322.054146318,1101563.80604605,114.129791259766,140,2.05739902295418,-0.222355628681235 +-145.47284,59.6292633,13.719616,478025.636487193,1101563.75243569,114.570297241211,140,2.05907203982817,-0.216278753868369 +-145.4075,59.6250057,13.719616,481729.586565928,1101563.74956317,114.805465698242,140,2.05996256459576,-0.21304411373139 +-145.34217,59.6207157,13.719616,485433.912699785,1101563.7869718,116.26399230957,140,2.06544523181706,-0.193129501474598 +-145.27686,59.6163935,13.719616,489138.061344175,1101563.81383154,114.555786132812,140,2.05901702999062,-0.216478565299713 +-145.21157,59.6120389,13.719616,492842.042272726,1101563.80695993,119.230606079102,140,2.07638775158802,-0.153383146360394 +-145.1463,59.6076521,13.719616,496545.859396735,1101563.78753413,170.815979003906,140,2.23252849438946,0.413764598499462 +-145.08105,59.603233,13.719616,500249.521027891,1101563.74349206,173.658599853516,140,2.23969629514144,0.439800096724658 +-145.01581,59.5987816,13.719616,503953.591516873,1101563.74975786,175.263580322266,140,2.24369167930927,0.454312472418408 +-144.95059,59.594298,13.719616,507657.518675692,1101563.74169805,165.712142944336,140,2.21935433352794,0.365912285970551 +-144.88538,59.5897821,13.719616,511361.868343798,1101563.7843039,176.169540405273,140,2.24593082134369,0.462445675402175 +-144.8202,59.585234,13.719616,515065.530795224,1101563.73429908,214.18977355957,241,2.33079873170279,0.770710149539723 +-144.75503,59.5806538,13.719616,518769.626287138,1101563.75641547,117.569961547852,140,2.07029637615848,-0.175508760572116 +-144.68988,59.5760413,13.719616,522473.607193151,1101563.75062231,138.993835449219,140,2.14299553917671,0.0885553499171025 +-144.62474,59.5713966,13.719616,526178.036264914,1101563.80635946,142.72607421875,140,2.15450332038091,0.130354895898512 +-144.55963,59.5667198,13.719616,529881.803683123,1101563.77594325,143.841125488281,140,2.15788307254987,0.142631120453496 +-144.49453,59.5620108,13.719616,533586.032801588,1101563.8064868,150.737091064453,141,2.17822012996956,0.216501117775917 +-144.42946,59.5572697,13.719616,537289.613770506,1101563.74810483,247.121124267578,241,2.3929098711031,0.996315536125832 +-144.3644,59.5524965,13.719616,540993.668339846,1101563.76124131,564.306457519531,440,2.75151502005394,2.29887179321518 +-143.65,59.4978742,13.719616,581737.971291361,1101563.80010957,536.591491699219,440,2.72964378213135,2.21942921440752 +-143.58518,59.4927165,13.719616,585441.530229924,1101563.73096334,529.129089355469,440,2.72356163792459,2.1973371306318 +-142.22858,59.3770483,13.719616,663226.058100942,1101563.82043723,504.343109130859,241,2.70272609141412,2.12165647864869 +-142.16422,59.3711913,13.719616,666929.959686196,1101563.80528013,292.185272216797,241,2.46565832126229,1.26055867157897 +-142.09988,59.3653027,13.719616,670633.998485481,1101563.81556985,228.195098876953,241,2.35830631250309,0.870625534451642 +-142.03557,59.3593825,13.719616,674337.623389119,1101563.7494945,222.288070678711,241,2.34691615645777,0.829253236620832 +-141.97127,59.3534307,13.719616,678041.955805303,1101563.80931938,210.819213867188,241,2.3239101895397,0.745688998217705 +-141.907,59.3474473,13.719616,681745.887106041,1101563.7911647,200.043884277344,241,2.30112527870826,0.662927698616873 +-141.84275,59.3414324,13.719616,685449.97914583,1101563.80733724,190.988204956055,241,2.28100654693006,0.589850722340702 +-141.77853,59.335386,13.719616,689153.68076183,1101563.75384765,191.610427856445,141,2.28241914063646,0.594981665876723 +-141.71433,59.3293081,13.719616,692857.555801307,1101563.73314776,192.816345214844,141,2.28514384666082,0.604878575865731 +-141.65015,59.3231987,13.719616,696561.610598423,1101563.74504865,198.567565917969,141,2.29790831216948,0.651242757934375 +-141.58599,59.3170578,13.719616,700265.851481948,1101563.78937609,212.107376098633,240,2.32655577150211,0.755298507029425 +-141.52186,59.3108854,13.719616,703969.727267506,1101563.7599686,237.339660644531,240,2.37537031706204,0.932606869561549 +-141.45775,59.3046816,13.719616,707673.799681692,1101563.77254948,329.951812744141,340,2.51845051870394,1.45231500108038 +-141.39367,59.2984464,13.719616,711377.517497435,1101563.71986482,323.485626220703,340,2.50985498796695,1.42109358003488 +-141.3296,59.2921798,13.719616,715082.002005362,1101563.81546961,336.693420410156,340,2.52723462958238,1.48422139902572 +-141.26557,59.2858818,13.719616,718785.586952006,1101563.736231,322.674530029297,240,2.50876468618394,1.4171332927559 +-141.20155,59.2795524,13.719616,722489.951124713,1101563.80508123,277.886932373047,240,2.44386812456898,1.1814104576475 +-141.13756,59.2731917,13.719616,726193.983614768,1101563.81588966,223.502182006836,240,2.3492817674183,0.837845810842083 +-141.0736,59.2667996,13.719616,729897.692806043,1101563.75594319,182.444091796875,142,2.26112980389381,0.517652718245739 +-141.00966,59.2603762,13.719616,733601.640280736,1101563.74494969,177.57292175293,142,2.24937674055363,0.47496223753595 +-140.94574,59.2539215,13.719616,737305.832249105,1101563.7828672,171.613082885742,142,2.23455039311935,0.421108711793767 +-140.88185,59.2474355,13.719616,741009.717408075,1101563.75808875,161.28759765625,142,2.20760097323807,0.323220726654709 +-140.81798,59.2409183,13.719616,744713.857259739,1101563.79202543,154.88005065918,142,2.18999548201622,0.259272557429466 +-140.75414,59.2343698,13.719616,748417.702673336,1101563.76101814,149.040115356445,142,2.17330317803049,0.198641344895377 +-140.69032,59.22779,13.719616,752121.8173443,1101563.77666102,143.710220336914,142,2.15748765524688,0.141194851945696 +-140.62653,59.2211791,13.719616,755825.645474501,1101563.74708132,141.280258178711,142,2.15008147987369,0.11429350905736 +-140.56276,59.2145369,13.719616,759529.755178332,1101563.76309966,139,142,2.14301480025409,0.0886253116478125 +-140.49902,59.2078636,13.719616,763233.590604198,1101563.73174719,133,142,2.12385164096709,0.0190192474071795 +-140.4353,59.2011591,13.719616,766937.717629372,1101563.75594438,130,142,2.11394335230684,-0.0169704851139895 +-140.37161,59.1944235,13.719616,770641.582595487,1101563.730674,128,142,2.10720996964787,-0.0414280528301153 +-140.30794,59.1876568,13.719616,774345.74910061,1101563.77094745,126,142,2.10037054511756,-0.0662707948902998 +-140.2443,59.1808589,13.719616,778049.668020757,1101563.74876671,123,142,2.0899051114394,-0.10428423714156 +-140.18068,59.17403,13.719616,781753.898354558,1101563.80217051,120,142,2.07918124604762,-0.143236377140402 +-140.11709,59.16717,13.719616,785457.890955948,1101563.80207067,119,142,2.07554696139253,-0.156437136335818 +-140.05353,59.1602789,13.719616,789161.65189205,1101563.7469349,115,142,2.06069784035361,-0.21037338231028 +-139.98999,59.1533568,13.719616,792865.74239083,1101563.76556416,122.760887145996,142,2.0890600182513,-0.107353856814337 +-139.92648,59.1464037,13.719616,796569.610968605,1101563.73817459,117.046165466309,142,2.06835719040256,-0.18255243673634 +-139.86299,59.1394196,13.719616,800273.821151265,1101563.78377114,115.675262451172,142,2.06324049352717,-0.201137740238461 +-139.79953,59.1324045,13.719616,803977.821443366,1101563.78148163,113.220878601074,142,2.0539265207139,-0.234968747968767 +-139.7361,59.1253585,13.719616,807681.615468503,1101563.74075781,116.131492614746,142,2.06495000797422,-0.194928295822745 +-139.67269,59.1182815,13.719616,811385.769096742,1101563.77139107,119.525169372559,142,2.07745936778314,-0.149490730469992 +-139.60931,59.1111736,13.719616,815089.728411247,1101563.76179462,121.733283996582,142,2.08540933812932,-0.120614169025224 +-139.54595,59.1040348,13.719616,818794.056877008,1101563.83382265,119.487991333008,142,2.07732426043167,-0.14998147893402 +-139.48263,59.0968651,13.719616,822497.645429904,1101563.74002501,117,142,2.06818586174616,-0.183174751318448 +-139.41933,59.0896646,13.719616,826201.612595884,1101563.73704321,108.924499511719,142,2.03712557310815,-0.295994585140707 +-139.35605,59.0824332,13.719616,829905.966728281,1101563.814237,104.674766540527,142,2.0198420009435,-0.35877345246535 +-139.29281,59.075171,13.719616,833609.596289382,1101563.73175603,100.859725952148,142,2.00371778379504,-0.417341211458336 +-139.22959,59.067878,13.719616,837313.622190735,1101563.73870978,97.0452423095703,40,1.98697424874707,-0.478158509833288 +-139.16639,59.0605542,13.719616,841018.050322416,1101563.83540629,94.3305435180664,40,1.97465233678386,-0.522915211107466 +-139.10323,59.0531996,13.719616,844721.771552995,1101563.76777479,92.7246704101562,40,1.96719529830364,-0.550001303318311 +-139.04009,59.0458143,13.719616,848425.904278825,1101563.7992073,93.6676483154297,40,1.97158961667019,-0.534039884747677 +-138.97698,59.0383983,13.719616,852129.896832976,1101563.80173239,96.8717956542969,40,1.98619735006742,-0.480980427586722 +-138.9139,59.0309515,13.719616,855833.757567821,1101563.76313802,105.595855712891,40,2.02364687391426,-0.344953067816708 +-138.85084,59.0234741,13.719616,859538.044794635,1101563.83333005,130.838470458984,142,2.11673545844969,-0.00682875865670965 +-138.78782,59.015966,13.719616,863241.651827773,1101563.74182373,150.563049316406,142,2.17771840183158,0.21467869797128 +-138.72482,59.0084273,13.719616,866945.696950325,1101563.7576337,155.27507019043,142,2.19110173423579,0.263290781246777 +-138.66185,59.0008579,13.719616,870649.630992727,1101563.73917495,149.530395507812,142,2.17472948202207,0.203822088100519 +-138.5989,58.9932579,13.719616,874354.014697382,1101563.82772911,140.576141357422,142,2.14791161829361,0.106411952458344 +-138.53599,58.9856273,13.719616,878057.738815696,1101563.75928764,102.882942199707,142,2.01234337551431,-0.386010600344972 +-138.4731,58.9779662,13.719616,881761.921533908,1101563.80736085,74.7224884033203,40,1.87345132630871,-0.89050616679743 +-138.41024,58.9702745,13.719616,885466.013668007,1101563.82818605,67.4260787963867,40,1.82882790375778,-1.05259117429525 +-138.34741,58.9625523,13.719616,889170.018355801,1101563.83142029,67.6288833618164,40,1.83013221673475,-1.04785353727491 +-138.28461,58.9547996,13.719616,892873.941308437,1101563.81585605,64,40,1.80617997398389,-1.13485491959676 +-138.22184,58.9470164,13.719616,896577.788230815,1101563.78029831,50.1806564331055,40,1.70053633819443,-1.51858275847977 +-138.1591,58.9392027,13.719616,900281.564821579,1101563.72356456,42.3247528076172,40,1.62659443034621,-1.78716087290619 +-138.09638,58.9313585,13.719616,903985.834280808,1101563.78060446,36.0920677185059,40,1.5574117635506,-2.03845206540691 +-138.03369,58.923484,11.05390693,907690.039463529,1101563.83696985,12.4557819366455,40,1.09537099643382,-3.7167160111397 +-152.80167,59.8655589,12.6263148,66881.917152491,1097859.77392003,17.6131496429443,32,1.24583702491899,-3.17018044840128 +-152.73532,59.8649448,13.719616,70585.9551993345,1097859.78143571,18.9462966918945,32,1.27752433391099,-3.05508309768388 +-152.66898,59.8642975,13.719616,74289.5763305319,1097859.76772909,21.9697208404541,32,1.34182453856727,-2.82152640126665 +-152.60263,59.8636172,13.719616,77993.9036320786,1097859.77734038,30.3837928771973,32,1.48264198686777,-2.31003723573793 +-152.53629,59.8629038,13.719616,81697.8285774678,1097859.77654014,35.592170715332,32,1.55135447580778,-2.06045386341087 +-152.46995,59.8621573,13.719616,85401.9166229129,1097859.77691527,43.3271408081055,32,1.63676003054758,-1.75023651142366 +-152.40362,59.8613778,13.719616,89105.6168241719,1097859.77664738,62.4960060119629,32,1.79585226338583,-1.17236811231099 +-152.33728,59.8605651,13.719616,92810.0532278072,1097859.78009116,74.6303329467773,32,1.8729153791338,-0.892452879911228 +-152.27096,59.8597194,13.719616,96513.5584771109,1097859.76813695,88.4380874633789,32,1.94663934208078,-0.62466640357378 +-152.20463,59.8588406,13.719616,100217.814424826,1097859.77200481,60.9000015258789,32,1.78461730351433,-1.21317669334107 +-152.13831,59.8579288,13.719616,103921.712013277,1097859.77374333,45.8682098388672,32,1.66151179066015,-1.66033105383909 +-152.07199,59.8569839,13.719616,107625.816984823,1097859.7772178,33.862663269043,32,1.52972111199984,-2.13903241553811 +-152.00568,59.8560059,13.719616,111329.578658842,1097859.76619477,35.4744987487793,32,1.54991626763403,-2.06567784600341 +-151.93937,59.8549949,13.719616,115033.562137714,1097859.7680489,29.7030620574951,32,1.47280122258743,-2.34578170043789 +-151.87306,59.8539508,13.719616,118737.775128888,1097859.77216918,17.2412948608398,32,1.23656987922652,-3.20384136666304 +-149.75422,59.8031104,11.7561589,237265.662207614,1097859.77042962,163.612976074219,33,2.21381774440836,0.345801813988357 +-149.68812,59.8009778,13.03305103,240969.83002307,1097859.77830937,274.877960205078,33,2.43913991938134,1.16423626684187 +-149.62203,59.7988123,5.975867463,244673.917141876,1097859.7806974,61.5713500976562,33,1.78937867663085,-1.19588202715071 +-149.55595,59.796614,13.53149619,248377.93007608,1097859.78828304,121.934265136719,33,2.08612576524678,-0.118011901245952 +-149.48988,59.7943827,13.35100499,252081.877567732,1097859.77829962,258.206512451172,33,2.41196719178764,1.06553716435296 +-149.42382,59.7921186,13.719616,255785.765365607,1097859.77262955,271.721527099609,133,2.4341240466999,1.14601718559029 +-149.35777,59.7898216,13.719616,259489.601470619,1097859.75970078,265.016754150391,133,2.42327333055968,1.10660428746627 +-149.29172,59.7874918,13.719616,263193.950406937,1097859.78990272,263.967163085938,133,2.42154990498515,1.10034431386498 +-149.22569,59.7851291,13.719616,266897.704062156,1097859.7729965,154.276977539062,133,2.18830112195596,0.253118158072106 +-149.15966,59.7827335,13.719616,270601.985813384,1097859.78844168,154.465347290039,133,2.18883106519328,0.255043063170879 +-149.09365,59.7803051,13.719616,274305.685948102,1097859.7661129,185.097595214844,133,2.26740077644222,0.54043068045533 +-149.02764,59.7778439,13.719616,278009.927805368,1097859.7877341,196.013854980469,133,2.29228676997333,0.630823712130044 +-148.96165,59.7753498,13.719616,281713.603307546,1097859.75867961,186.971343994141,133,2.27177504985807,0.556319290043627 +-148.89566,59.7728229,13.719616,285417.834963373,1097859.77409237,192.737213134766,133,2.28496557505389,0.604231042505583 +-148.82969,59.7702633,13.719616,289121.512972927,1097859.75945092,189.545776367188,133,2.27771411152235,0.577891657185288 +-148.76372,59.7676708,13.719616,292825.762393713,1097859.77871411,186.998779296875,133,2.27183877152922,0.556550745341221 +-148.69776,59.7650455,13.719616,296530.031497249,1097859.79981682,180.957229614258,133,2.25757593875042,0.50474406567085 +-148.63182,59.7623874,13.719616,300233.769411109,1097859.77733103,173.718307495117,133,2.23984558946113,0.440342376306636 +-148.56589,59.7596965,13.719616,303937.541391161,1097859.75514799,175.350738525391,133,2.24390759934114,0.455096755603865 +-148.49996,59.7569729,13.719616,307641.911765542,1097859.7905519,158.787109375,133,2.20081524270984,0.29857301653585 +-148.43405,59.7542164,13.719616,311345.773427458,1097859.76899704,148.386047363281,133,2.17139306645504,0.191703274453254 +-148.36815,59.7514273,13.719616,315049.688816326,1097859.76953131,130.137710571289,133,2.11440316220265,-0.0153003243295898 +-148.30226,59.7486054,13.719616,318753.666961867,1097859.76973541,162.821487426758,133,2.21171171784485,0.338152124389876 +-148.23638,59.7457507,13.719616,322457.715040874,1097859.7694964,148.321319580078,133,2.17120358063401,0.191015007866601 +-148.17051,59.7428633,13.719616,326161.839246991,1097859.77985863,84.7117080688477,33,1.92794343864587,-0.692575261191486 +-148.10465,59.7399432,13.719616,329866.046718205,1097859.80074166,64.1749801635742,33,1.80736574310349,-1.13054786770217 +-148.03881,59.7369903,13.719616,333569.787526597,1097859.77071707,35.5193519592285,33,1.55046503359591,-2.06368457139648 +-147.97298,59.7340048,13.719616,337273.624876042,1097859.76112839,35.1003913879395,33,1.54531195910613,-2.08240200877725 +-147.90716,59.7309865,13.719616,340977.56791171,1097859.74967396,40.2360458374023,33,1.60461529423039,-1.86699536874889 +-147.84135,59.7279356,13.719616,344681.621721965,1097859.75861585,67.5429534912109,33,1.82958004736973,-1.04985917401348 +-147.77555,59.724852,13.719616,348385.794443603,1097859.77682511,80.4909515380859,33,1.90574706151134,-0.77319883842091 +-147.70977,59.7217357,13.719616,352089.53513147,1097859.75131014,100.063255310059,133,2.00027462747202,-0.429847737998211 +-147.64399,59.7185867,13.719616,355793.967033741,1097859.78758937,113.487007141113,33,2.05494614302767,-0.231265188695979 +-147.57823,59.7154051,13.719616,359497.980054023,1097859.79026202,110.631057739258,33,2.04387706468399,-0.271471240669701 +-147.51249,59.7121909,13.719616,363201.581270309,1097859.75772933,121.570236206055,133,2.08482726051488,-0.122728441062376 +-147.44675,59.708944,13.719616,366905.89499004,1097859.7877773,126.194313049316,133,2.10103978385462,-0.0638399287775506 +-147.38103,59.7056645,13.719616,370609.81107435,1097859.78170782,112.931022644043,133,2.05281326090116,-0.23901242536463 +-147.31532,59.7023523,13.719616,374313.895780868,1097859.78321176,91.1130599975586,33,1.9595806324983,-0.577659942965335 +-147.24963,59.6990076,13.719616,378017.595873047,1097859.75776507,111.455955505371,33,2.04710327940232,-0.259752707959381 +-147.18394,59.6956302,13.719616,381722.036802166,1097859.79656276,207.569931030273,140,2.31716444101918,0.721186514162842 +-147.11828,59.6922203,13.719616,385425.549150198,1097859.74959593,202.121322631836,230,2.30561213149093,0.679225228598835 +-147.05262,59.6887778,13.719616,389129.815303609,1097859.77837193,207.869979858398,230,2.31779177397203,0.723465166506235 +-146.98698,59.6853027,13.719616,392833.726183527,1097859.76647366,174.310745239258,140,2.24132415965319,0.445712965270132 +-146.92135,59.6817951,13.719616,396537.845714429,1097859.78328711,112.321380615234,140,2.05046243301483,-0.247551303240834 +-146.85574,59.6782549,13.719616,400241.624043801,1097859.75767157,101.744560241699,140,2.00751119902585,-0.403562444591548 +-146.79014,59.6746822,13.719616,403945.625067312,1097859.7601606,95.9334945678711,41,1.98197026479626,-0.496334407821831 +-146.72455,59.6710769,13.719616,407649.857012983,1097859.77991767,95.1017379760742,41,1.9781884537042,-0.510071025144527 +-146.65898,59.6674392,13.719616,411353.766383072,1097859.77752991,94.4944229125977,41,1.97540617708324,-0.520177047972675 +-146.59342,59.6637689,13.719616,415057.920697627,1097859.79190613,91.1150512695312,41,1.95959012388164,-0.577625467551932 +-146.52788,59.6600661,13.719616,418761.76766346,1097859.77143574,92.1937713623047,41,1.96470158098469,-0.559059196398532 +-146.46235,59.6563309,13.719616,422465.871070872,1097859.78951686,92.0595932006836,41,1.96406905147161,-0.561356724131925 +-146.39684,59.6525631,13.719616,426169.682364055,1097859.76012045,90.5864334106445,41,1.95706316085485,-0.586804118532291 +-146.33134,59.6487629,13.719616,429873.764048654,1097859.76890324,88.7803955078125,41,1.94831707543228,-0.618572397168348 +-146.26586,59.6449303,13.719616,433577.565006751,1097859.75097279,89.8020706176758,41,1.95328635055888,-0.600522571536229 +-146.20039,59.6410652,13.719616,437281.651557938,1097859.75980692,93.0875091552734,41,1.96889140956484,-0.543840543099305 +-146.13493,59.6371677,13.719616,440986.029353992,1097859.80694188,97.4128494262695,41,1.98861624709278,-0.472194303168673 +-146.0695,59.6332377,13.719616,444689.590532561,1097859.74780006,103.78150177002,140,2.01611995086183,-0.372293000740836 +-146.00407,59.6292754,13.719616,448394.01356931,1097859.80425751,105.913711547852,140,2.02495218734164,-0.340211796874893 +-145.93867,59.6252806,13.719616,452097.633871947,1097859.75203583,119.078704833984,140,2.0758341023728,-0.155394158337283 +-145.87328,59.6212535,13.719616,455801.571799316,1097859.74775244,132.609634399414,140,2.12257507772263,0.0143824053358806 +-145.8079,59.617194,13.719616,459505.835615687,1097859.78081893,138.26904296875,140,2.14072495687883,0.0803079469224825 +-145.74254,59.6131021,13.719616,463209.874172891,1097859.78201602,146.545471191406,140,2.16597240164192,0.172013872640211 +-145.6772,59.6089779,13.719616,466913.69298661,1097859.76131125,127.903915405273,140,2.10688383934087,-0.0426126511919905 +-145.61187,59.6048214,13.719616,470617.856999013,1097859.78845472,126.298133850098,140,2.10139693357518,-0.0625426590517873 +-145.54656,59.6006325,13.719616,474321.816436914,1097859.78150841,124.923118591309,140,2.0966428174577,-0.0798109657503104 +-145.48127,59.5964113,13.719616,478025.576771374,1097859.75048581,123.733024597168,140,2.09248562918562,-0.0949110601341907 +-145.41599,59.5921578,13.719616,481729.702932617,1097859.76686023,122.394248962402,140,2.08776101174277,-0.112072219226678 +-145.35073,59.587872,13.719616,485433.643715896,1097859.75816197,117.287788391113,140,2.06925279719283,-0.179299337242463 +-145.28548,59.5835539,13.719616,489137.964043329,1097859.79701302,115.070472717285,140,2.0609638972086,-0.209406987872762 +-145.22026,59.5792036,13.719616,492841.553162567,1097859.7467349,117.860443115234,140,2.07136806956194,-0.171616064238995 +-145.15505,59.574821,13.719616,496545.535505182,1097859.74310628,115.37678527832,140,2.06211843412519,-0.20521338025408 +-145.08985,59.5704062,13.719616,500249.916419718,1097859.79790033,194.861968994141,140,2.28972708658991,0.621526211475115 +-145.02468,59.5659591,13.719616,503953.588089356,1097859.74897296,186.762176513672,140,2.27128892652654,0.554553551350116 +-144.95952,59.5614798,13.719616,507657.671963436,1097859.75766442,189.208053588867,140,2.27693961808462,0.575078475956999 +-144.89438,59.5569683,13.719616,511361.616775564,1097859.7477119,206.660369873047,140,2.31525720233802,0.71425887889277 +-144.82925,59.5524247,13.719616,515065.985846826,1097859.80682782,227.929412841797,241,2.35780037173879,0.868787813185844 +-144.76415,59.5478488,13.719616,518769.672904395,1097859.7573994,155.072113037109,140,2.19053370469289,0.261227535815172 +-144.69906,59.5432408,13.719616,522473.797776187,1097859.77636055,171.506042480469,140,2.23427942565982,0.420124480638927 +-144.63399,59.5386006,13.719616,526177.810717865,1097859.77420749,168.478317260742,140,2.22654401618695,0.392027265527798 +-144.56894,59.5339283,13.719616,529881.716924408,1097859.76115444,195.735595703125,140,2.29166981192118,0.628582744387278 +-144.50391,59.5292239,13.719616,533585.523136474,1097859.73635807,313.569152832031,241,2.49633333266751,1.37197906852265 +-144.43889,59.5244874,13.719616,537289.794155803,1097859.7798948,544.80126953125,341,2.73623811092707,2.24338169880243 +-142.2401,59.3444389,13.719616,663226.05900384,1097859.81972793,653.974304199219,341,2.81556068446536,2.53150392681007 +-142.1758,59.3385875,13.719616,666929.977401811,1097859.8093577,379.146636962891,241,2.57880720814024,1.6715477246273 +-142.11152,59.3327045,13.719616,670634.030104582,1097859.82075307,305.825805664062,241,2.48547412850814,1.33253533949036 +-142.04727,59.3267899,13.719616,674337.665442611,1097859.75209573,259.043701171875,241,2.41337303657853,1.07064359390153 +-141.98303,59.3208438,13.719616,678042.003925343,1097859.81664268,236.228118896484,241,2.37333159164644,0.925201636941928 +-141.91882,59.3148661,13.719616,681745.937798064,1097859.79950556,213.725296020508,241,2.32985592727385,0.767285614750653 +-141.85463,59.308857,13.719616,685450.027439556,1097859.82397901,199.694412231445,241,2.30036591278757,0.66016946484833 +-141.79047,59.3028163,13.719616,689153.725183289,1097859.7640768,198.289886474609,141,2.29730056412826,0.649035243580078 +-141.72633,59.2967441,13.719616,692857.593409495,1097859.73324041,196.990127563477,141,2.29444446142991,0.638661063366816 +-141.66221,59.2906405,13.719616,696561.636385119,1097859.74226249,198.049240112305,240,2.29677318041531,0.64711963540437 +-141.59811,59.2845055,13.719616,700265.860405107,1097859.79095616,199.650909423828,240,2.30027129277654,0.659825777961023 +-141.53404,59.278339,13.719616,703969.715779942,1097859.7621631,270.468231201172,340,2.43211626085004,1.13872433430447 +-141.46999,59.2721411,13.719616,707673.764794039,1097859.77160017,316.210845947266,340,2.49997676203599,1.38521304392727 +-141.40596,59.2659118,13.719616,711378.013726104,1097859.81912417,332.387634277344,340,2.52164485847847,1.46391775489681 +-141.34196,59.2596511,13.719616,715081.910783935,1097859.79693123,347.338653564453,340,2.54075311643959,1.5333244018514 +-141.27798,59.2533591,13.719616,718786.01817207,1097859.82244263,334.810211181641,240,2.52479869481768,1.47537338867533 +-141.21403,59.2470357,13.719616,722489.78619488,1097859.77578793,295.141632080078,240,2.47003047451989,1.27643958014736 +-141.1501,59.240681,13.719616,726193.777024763,1097859.7755285,234.732986450195,240,2.37057412422434,0.915185728205308 +-141.08619,59.234295,13.719616,729897.99688126,1097859.82158699,199.559356689453,142,2.30007209525376,0.659102235701648 +-141.02231,59.2278776,13.719616,733601.896083809,1097859.79246907,185.18603515625,142,2.26760823351627,0.541184223762429 +-140.95845,59.221429,13.719616,737306.034575034,1097859.81941128,177.521728515625,142,2.24925151793702,0.474507393250313 +-140.89462,59.2149492,13.719616,741009.860460698,1097859.79079336,169.659042358398,142,2.22957701129445,0.40304396946123 +-140.83081,59.2084381,13.719616,744713.940174384,1097859.80609135,162.388809204102,142,2.21055609714428,0.3339545801584 +-140.76703,59.2018958,13.719616,748417.719629213,1097859.76356312,155.005569458008,142,2.19034730295368,0.260550471494011 +-140.70327,59.1953223,13.719616,752121.763045022,1097859.77478941,146.915390014648,142,2.16706729237533,0.175990828296895 +-140.63954,59.1887175,13.719616,755825.520739102,1097859.71502101,146,142,2.16435285578444,0.166131219821422 +-140.57583,59.1820817,13.719616,759529.550217882,1097859.72984571,140,142,2.14612803567824,0.0999334713141587 +-140.51214,59.1754146,13.719616,763233.864320785,1097859.78644357,136,142,2.13353890837022,0.0542061676367513 +-140.44848,59.1687165,13.719616,766937.904348916,1097859.802239,132,142,2.12057393120585,0.00711367000286348 +-140.38485,59.1619872,13.719616,770641.680917236,1097859.75372556,129,142,2.11058971029925,-0.0291518701102782 +-140.32124,59.1552268,13.719616,774345.755924871,1097859.76685776,124,142,2.09342168516224,-0.0915110376501457 +-140.25766,59.1484354,13.719616,778049.575092341,1097859.73551271,120,142,2.07918124604762,-0.143236377140402 +-140.1941,59.1416128,13.719616,781753.70714566,1097859.75395315,116,142,2.06445798922692,-0.19671544834909 +-140.13057,59.1347593,13.719616,785457.593168519,1097859.73684403,118,142,2.07188200730613,-0.169749295659684 +-140.06706,59.1278747,13.719616,789161.801885794,1097859.77959323,113,142,2.05307844348342,-0.238049206535204 +-140.00358,59.1209591,13.719616,792865.77895296,1097859.77389284,112,142,2.04921802267018,-0.252071356802685 +-139.94013,59.1140125,13.719616,796569.530392513,1097859.71822394,117,142,2.06818586174616,-0.183174751318448 +-139.8767,59.107035,13.719616,800273.617926942,1097859.74251193,119.229156494141,142,2.07638247147918,-0.153402325222776 +-139.81329,59.1000265,13.719616,803978.049905754,1097859.83600603,117.535018920898,142,2.07016728157146,-0.175977668959459 +-139.74992,59.092987,13.719616,807681.716202893,1097859.75566398,118.435607910156,142,2.07348229355219,-0.163936599246807 +-139.68657,59.0859167,13.719616,811385.734166483,1097859.76454194,119.230537414551,142,2.07638750147905,-0.153384054827561 +-139.62325,59.0788154,13.719616,815089.556464144,1097859.71827694,121.841011047363,142,2.08579349415652,-0.119218804685372 +-139.55995,59.0716833,13.719616,818793.742325057,1097859.76055501,117.635643005371,142,2.07053893071291,-0.174627733198475 +-139.49668,59.0645204,13.719616,822497.739602453,1097859.76776124,116.712982177734,142,2.06711916602459,-0.187049294644479 +-139.43344,59.0573266,13.719616,826201.55664152,1097859.72755889,113.562210083008,142,2.05523383592775,-0.23022020596716 +-139.37022,59.0501019,13.719616,829905.757445628,1097859.76350796,107.585105895996,142,2.03175215167511,-0.315512385512701 +-139.30703,59.0428465,13.719616,833609.784974855,1097859.77218045,103.745277404785,142,2.015968336288,-0.372843708148097 +-139.24387,59.0355603,13.719616,837313.647556397,1097859.74127927,100.925941467285,142,2.00400280932971,-0.41630591736203 +-139.18073,59.0282434,13.719616,841017.906670554,1097859.80697195,98.8600921630859,40,1.99502101099934,-0.448930372558422 +-139.11762,59.0208957,13.719616,844722.012587745,1097859.83146958,98.9716720581055,40,1.99551090743258,-0.447150928882533 +-139.05454,59.0135172,13.719616,848425.971184591,1097859.81342574,100.725738525391,142,2.00314046033767,-0.419438215040047 +-138.99149,59.0061081,13.719616,852129.783321778,1097859.77329637,106.40299987793,142,2.02695387243333,-0.33294110528409 +-138.92846,58.9986683,13.719616,855834.015382438,1097859.8277235,119.716178894043,142,2.07815284656011,-0.146971817613504 +-138.86547,58.9911978,13.719616,859537.557062997,1097859.71821173,161.169525146484,142,2.20728292635294,0.322065489588305 +-138.8025,58.9836967,13.719616,863241.527779695,1097859.71264267,178.70329284668,142,2.25213255503484,0.484972142319466 +-138.73955,58.976165,13.719616,866945.933316682,1097859.81139315,168.249786376953,142,2.22595452148223,0.389886052501713 +-138.67664,58.9686026,13.719616,870649.665877542,1097859.74177014,155.421249389648,142,2.19151039581479,0.264775156745322 +-138.61375,58.9610097,13.719616,874353.842262375,1097859.78591265,142.504730224609,142,2.15382928031892,0.127906590003182 +-138.55089,58.9533862,13.719616,878057.912717617,1097859.80113527,90.0269088745117,40,1.95437233865069,-0.596577952814911 +-138.48806,58.9457322,13.719616,881761.880415429,1097859.79706756,75.4486465454102,40,1.8776514534803,-0.875250106074539 +-138.42526,58.9380476,13.719616,885465.753675914,1097859.7615967,67.0359039306641,40,1.8263074699024,-1.06174610946142 +-138.36249,58.9303326,13.719616,889169.53303039,1097859.71524249,66.8592910766602,40,1.82516176736384,-1.06590762809755 +-138.29974,58.922587,13.719616,892873.787459894,1097859.7694938,62.9275016784668,40,1.79884048991062,-1.16151402064818 +-138.23702,58.914811,13.719616,896577.959376776,1097859.81155433,55.8145332336426,40,1.74674729717,-1.35073136555963 +-138.17433,58.9070046,13.719616,900282.05444788,1097859.84022627,49.4000015258789,40,1.69372696233824,-1.54331635517883 +-138.11168,58.8991677,13.719616,903985.522917233,1097859.70734454,39.8608093261719,40,1.60054611228525,-1.8817757990338 +-138.04904,58.8913005,13.719616,907690.039348067,1097859.84181766,29.3000831604004,40,1.46686885298386,-2.36732976010491 +-137.98644,58.8834028,13.11922336,911393.940500032,1097859.81240841,15.6629257202148,40,1.19487288833916,-3.35529673907203 +-152.93544,59.8335705,13.719616,59473.8853466283,1094155.77618927,13.4248580932617,32,1.12790970370946,-3.59852613884285 +-152.86915,59.8330231,13.719616,63178.0106110744,1094155.78337121,16.2091255187988,32,1.20975958532324,-3.30122400653947 +-152.80287,59.8324426,13.719616,66881.7032152993,1094155.77799013,23.6631832122803,32,1.37407316626566,-2.70439018079134 +-152.73659,59.831829,13.719616,70585.5291720981,1094155.76932709,27.6188430786133,32,1.44120548253018,-2.4605464466479 +-152.6703,59.8311824,13.719616,74290.0542697681,1094155.78009326,28.6173076629639,32,1.45662877260617,-2.4045246548466 +-152.60403,59.8305028,13.719616,77993.6099935834,1094155.77709157,31.9182510375977,32,1.50403908613952,-2.23231686384274 +-152.53775,59.8297901,13.719616,81697.8798135453,1094155.78308135,33.8584976196289,32,1.52966768354313,-2.13922648294287 +-152.47148,59.8290443,13.719616,85401.7538702173,1094155.77441635,53.729419708252,32,1.73021215010033,-1.41079173931752 +-152.40521,59.8282655,13.719616,89105.7979044988,1094155.77443859,64.1961364746094,32,1.80750889164755,-1.13002791133147 +-152.33894,59.8274537,13.719616,92810.0192683625,1094155.78358392,82.9358673095703,32,1.91874239069323,-0.725996093596038 +-152.27268,59.8266088,13.719616,96513.8669806115,1094155.7765948,83.9555282592773,32,1.92404929860927,-0.706719889302638 +-152.20642,59.8257309,13.719616,100217.906746246,1094155.77854105,53.8100852966309,32,1.7308636804655,-1.40842519506595 +-152.14017,59.82482,13.719616,103921.587291524,1094155.77426566,41.9360809326172,32,1.62258784175006,-1.80171394628164 +-152.07391,59.823876,13.719616,107626.03353567,1094155.78383894,33.3238410949707,32,1.52275505486576,-2.16433512335972 +-152.00767,59.822899,13.719616,111329.576654716,1094155.77034985,35.8805046081543,32,1.55485854214786,-2.0477260943036 +-151.94142,59.821889,13.719616,115033.899864877,1094155.78296297,27.8984394073486,32,1.44557991023657,-2.44465727663228 +-151.87518,59.8208459,13.71952332,118737.89362312,1094155.77698095,16.9266223907471,32,1.22857030581099,-3.23289810061382 +-149.75845,59.7700556,9.380740533,237265.524173508,1094155.76380325,61.3144035339355,33,1.7875625078058,-1.20247887070945 +-149.69241,59.7679251,13.719616,240969.996359037,1094155.79162199,287.715942382812,33,2.45896392687837,1.23624272040616 +-149.62639,59.7657617,8.864523515,244673.827957349,1094155.77404654,118.700950622559,33,2.07445419703781,-0.160406368378152 +-149.49437,59.7613365,12.94215661,252081.830633584,1094155.77945602,92.030403137207,33,1.96393132444839,-0.561856987991483 +-149.42837,59.7590746,13.719616,255786.016920071,1094155.79150763,263.901245117188,133,2.42144143927745,1.0999503354554 +-149.36239,59.7567799,13.719616,259489.590806456,1094155.76531025,243.66064453125,133,2.38678538867117,0.974069667831718 +-149.29641,59.7544523,13.719616,263193.677544554,1094155.7668967,238.200805664062,133,2.37694322605887,0.93832012399097 +-149.23044,59.7520919,13.719616,266897.724953737,1094155.76852415,256.498138427734,133,2.40908421750438,1.05506537887336 +-149.16448,59.7496987,13.719616,270601.740243426,1094155.76982706,146.288116455078,133,2.16520904815127,0.169241154879407 +-149.09853,59.7472727,13.719616,274305.730620673,1094155.77045779,174.721115112305,133,2.24234539280564,0.449422375568781 +-149.03259,59.7448139,13.719616,278009.703290134,1094155.77008659,189.527160644531,133,2.2776714563769,0.577736721522011 +-148.96666,59.7423223,13.719616,281713.665454029,1094155.76840157,191.532592773438,133,2.28224268774188,0.594340738598945 +-148.90074,59.7397979,13.719616,285417.624312112,1094155.76510872,187.998672485352,133,2.27415478259175,0.564963158575725 +-148.83483,59.7372407,13.719616,289121.587061648,1094155.75993187,184.915145874023,133,2.26697248444269,0.538875001666318 +-148.76893,59.7346507,13.719616,292825.560897364,1094155.75261268,188.145492553711,133,2.27449381828437,0.56619463298174 +-148.70304,59.732028,13.719616,296529.552120456,1094155.75405764,190.796203613281,133,2.28056972903576,0.588264075068358 +-148.63716,59.7293725,13.719616,300233.568789361,1094155.75289524,190.483093261719,133,2.27985643497761,0.585673187454758 +-148.57129,59.7266843,13.719616,303937.617177954,1094155.76006574,184.608963012695,133,2.26625278278122,0.536260839808553 +-148.50543,59.7239633,13.719616,307641.705361521,1094155.76423491,167.589157104492,133,2.22424591666885,0.383679912135153 +-148.43958,59.7212096,13.719616,311345.839586495,1094155.77637668,158.556793212891,133,2.20018485368995,0.296283263684691 +-148.37374,59.7184232,13.719616,315050.02699864,1094155.79633654,139.205612182617,133,2.1436567445476,0.0909570365509742 +-148.30792,59.715604,13.719616,318753.717075063,1094155.76483906,174.75634765625,133,2.24243295953655,0.449740442929481 +-148.2421,59.7127522,13.719616,322458.032298903,1094155.79948538,140.787750244141,133,2.1485648690617,0.108784745704381 +-148.1763,59.7098676,13.719616,326161.864486811,1094155.78134012,82.3514099121094,33,1.91567103898613,-0.737152119647276 +-148.11051,59.7069503,13.719616,329865.778439326,1094155.76945792,68.3578567504883,33,1.83478843766444,-1.0309408138405 +-148.04473,59.7040004,13.719616,333569.780286786,1094155.77491001,36.0790901184082,33,1.55725557649914,-2.03901938135803 +-147.97896,59.7010178,13.719616,337273.87813741,1094155.78650817,38.5016555786133,33,1.58547940465648,-1.93650238160799 +-147.91321,59.6980025,13.719616,340977.520493943,1094155.75287773,68.8012619018555,33,1.83759640381671,-1.02074147930211 +-147.84746,59.6949545,13.719616,344681.831725769,1094155.77613439,81.6312408447266,33,1.91185639809101,-0.751007984185247 +-147.78173,59.6918739,13.719616,348385.700660971,1094155.76417077,99.3335266113281,33,1.99709585438496,-0.441393949162564 +-147.71601,59.6887607,13.719616,352089.693006673,1094155.76834872,115.24333190918,133,2.06161580608922,-0.207039068745044 +-147.6503,59.6856148,13.719616,355793.81691131,1094155.77757272,118.819473266602,133,2.07488762279311,-0.158832042322903 +-147.58461,59.6824363,13.719616,359497.519783983,1094155.74889723,118.893333435059,133,2.07515750362175,-0.157851758121623 +-147.51892,59.6792252,13.719616,363201.925945812,1094155.7900996,122.629112243652,133,2.08859358425982,-0.109048078204908 +-147.45325,59.6759815,13.719616,366905.925221996,1094155.79244571,125.27172088623,133,2.09785304346677,-0.0754150794525033 +-147.3876,59.6727052,13.719616,370609.524680963,1094155.75436783,122.962730407715,133,2.08977349817938,-0.104762294068115 +-147.32195,59.6693963,13.719616,374313.848634359,1094155.78704184,105.104934692383,33,2.02162310669771,-0.35230396798787 +-147.25632,59.6660548,13.719616,378017.786897807,1094155.77843935,125.764739990234,133,2.09955889727684,-0.0692189315151782 +-147.1907,59.6626807,13.719616,381721.905153275,1094155.78452326,207.570419311523,230,2.31716546263923,0.721190224978458 +-147.1251,59.6592741,13.719616,385425.650677528,1094155.75855439,200.520904541016,230,2.30215965502882,0.666684848653537 +-147.05951,59.655835,13.719616,389129.589112989,1094155.75764227,205.646499633789,230,2.31312132166106,0.706500750632986 +-146.99393,59.6523633,13.719616,392833.728653042,1094155.77087266,204.190414428711,230,2.31003535058914,0.695291622875961 +-146.92837,59.6488591,13.719616,396537.5165315,1094155.74988141,128.114440917969,140,2.10759808569714,-0.0400183045598018 +-146.86282,59.6453223,13.719616,400241.519580145,1094155.74238521,111.71395111084,140,2.04810741225718,-0.256105410822464 +-146.79728,59.6417531,13.719616,403945.742416804,1094155.770878,101.133148193359,140,2.00489352668811,-0.413070577680284 +-146.73176,59.6381514,13.719616,407649.634609023,1094155.76313264,101.508026123047,140,2.00650038277279,-0.407234017738323 +-146.66625,59.6345171,13.719616,411353.763011143,1094155.76859409,101.59642791748,41,2.00687843862704,-0.405860810967797 +-146.60076,59.6308504,13.719616,415057.573541549,1094155.74730212,97.5261306762695,41,1.98912099403759,-0.470360918195988 +-146.53528,59.6271513,13.719616,418761.631782327,1094155.76096169,99.122444152832,41,1.99617200229659,-0.444749643641193 +-146.46981,59.6234197,13.719616,422465.945954007,1094155.79880164,94.952522277832,41,1.97750650563749,-0.512548055170181 +-146.40436,59.6196556,13.719616,426169.964417992,1094155.79701037,89.8021087646484,41,1.95328653504256,-0.600521901438856 +-146.33893,59.6158591,13.719616,429873.69286816,1094155.76539938,95.9737319946289,41,1.98215238292673,-0.49567290279026 +-146.27351,59.6120302,13.719616,433577.696872201,1094155.76797252,99.0802001953125,41,1.9959868754232,-0.445422077285794 +-146.2081,59.6081688,13.719616,437281.984679896,1094155.79403164,103.752311706543,140,2.01599778201267,-0.372736752871473 +-146.14271,59.6042751,13.719616,440986.001998176,1094155.79980985,110.777618408203,140,2.04445202407756,-0.269382824042531 +-146.07734,59.600349,13.719616,444689.757058463,1094155.77296824,121.350914001465,140,2.08404305173757,-0.125576911177025 +-146.01198,59.5963905,13.719616,448393.815413585,1094155.77980923,136.854537963867,140,2.1362592027691,0.0640870533428004 +-145.94664,59.5923996,13.719616,452097.625366192,1094155.75273163,142.984832763672,140,2.15528997175601,0.133212238225547 +-145.88131,59.5883764,13.719616,455801.751097928,1094155.77028548,156.682281494141,140,2.19501988680423,0.277522629727416 +-145.816,59.5843208,13.719616,459505.642245532,1094155.75268653,164.901596069336,140,2.21722485916635,0.358177427276764 +-145.7507,59.5802329,13.719616,463209.862961108,1094155.77963111,163.179458618164,140,2.21266548793343,0.341616489584662 +-145.68542,59.5761127,13.719616,466913.861499146,1094155.7813501,159.938354492188,140,2.20395262351419,0.309968879114881 +-145.62016,59.5719602,13.719616,470617.64473343,1094155.75672442,152.384735107422,140,2.18294146444026,0.233650352176514 +-145.55491,59.5677754,13.719616,474321.778156988,1094155.77607381,142.581954956055,140,2.15406456507473,0.128761211393233 +-145.48968,59.5635583,13.719616,478025.710012483,1094155.76800588,136.046096801758,140,2.13368608627178,0.0547407597839995 +-145.42446,59.5593089,13.719616,481730.005784967,1094155.80398909,136.191055297852,140,2.13414858509256,0.0564206875113511 +-145.35927,59.5550273,13.719616,485433.553635114,1094155.74954073,124.05419921875,140,2.09361146966962,-0.0908216861494495 +-145.29408,59.5507134,13.719616,489138.037715281,1094155.81182062,118.528915405273,140,2.07382431042271,-0.162694296351756 +-145.22892,59.5463672,13.719616,492841.789005567,1094155.77052332,116.511642456055,140,2.06636932451902,-0.189772933018779 +-145.16377,59.5419889,13.719616,496545.928631151,1094155.79467562,118.647819519043,140,2.07425976126765,-0.161112614592874 +-145.09864,59.5375783,13.719616,500249.907733568,1094155.78746625,150.822631835938,140,2.17846651490236,0.217396058177079 +-145.03353,59.5331356,13.719616,503953.730139845,1094155.77008515,213.512573242188,140,2.32942345467215,0.765714750821283 +-144.96843,59.5286606,13.719616,507657.964273044,1094155.79585457,227.999588012695,241,2.35793406224618,0.869273415267744 +-144.90335,59.5241535,13.719616,511362.055285158,1094155.81066498,247.010528564453,241,2.39271546500053,0.995609397672277 +-144.83829,59.5196142,13.719616,515066.011473344,1094155.80251107,255.087539672852,241,2.40668924503281,1.04636615526341 +-144.77325,59.5150428,13.719616,518769.838076865,1094155.78155772,204.490356445312,140,2.31067283194561,0.697607137117949 +-144.70823,59.5104392,13.719616,522473.543406039,1094155.73583524,215.529983520508,140,2.33350769571116,0.780549880033428 +-144.64322,59.5058036,13.719616,526177.689722849,1094155.7658392,401.297790527344,241,2.60346676859398,1.76111828673461 +-144.57823,59.5011358,13.719616,529881.728275969,1094155.77044661,593.555297851562,241,2.77346118568837,2.37858653085875 +-142.18736,59.3059822,13.719616,666929.860957806,1094155.79024698,620.14453125,341,2.79249291822287,2.44771521562136 +-142.12314,59.3001048,13.719616,670633.921272074,1094155.80288411,464.941986083984,241,2.6673987664482,1.99333755095005 +-142.05895,59.2941958,13.719616,674337.560754106,1094155.73177672,335.877807617188,241,2.52618130974284,1.4803954407211 +-141.99477,59.2882553,13.719616,678041.901028691,1094155.79017557,299.380493164062,241,2.47622349945661,1.2989344143828 +-141.93062,59.2822834,13.719616,681745.829180055,1094155.7851784,261.998596191406,241,2.4182989643428,1.08853596954111 +-141.86649,59.2762799,13.719616,685449.914208378,1094155.79608433,220.953750610352,241,2.34430137795332,0.819755614760598 +-141.80239,59.270245,13.719616,689153.599779151,1094155.74088173,205.841293334961,241,2.31353250195507,0.707994274823381 +-141.7383,59.2641786,13.719616,692858.011494988,1094155.81534165,201.982696533203,240,2.30531416587223,0.678142932423848 +-141.67424,59.2580808,13.719616,696562.036376445,1094155.82215076,202.64225769043,240,2.30673001539793,0.683285702024898 +-141.61021,59.2519516,13.719616,700265.680716484,1094155.75944237,206.140853881836,340,2.31416407065925,0.710288312624616 +-141.5462,59.2457909,13.719616,703969.511510215,1094155.72038199,260.682952880859,340,2.41611263181336,1.08059458575273 +-141.48221,59.2395989,13.719616,707673.530881749,1094155.72677582,318.295776367188,340,2.50283087577905,1.39557999968721 +-141.41824,59.2333755,13.719616,711377.747181596,1094155.76748769,340.518707275391,340,2.53214097599418,1.50204264960406 +-141.3543,59.2271207,13.719616,715081.608057867,1094155.73470711,348.832641601562,340,2.54261711675412,1.54009498303244 +-141.29038,59.2208347,13.719616,718785.674146396,1094155.75682485,345.900451660156,240,2.53895112909556,1.52677906947948 +-141.22648,59.2145173,13.719616,722489.955918513,1094155.81177398,329.098083496094,240,2.51732535318622,1.44822807876578 +-141.16261,59.2081686,13.719616,726193.898858172,1094155.80108587,268.493530273438,240,2.42893382522962,1.12716481977356 +-141.09876,59.2017886,13.719616,729898.067806247,1094155.83290923,213.863311767578,142,2.33013628778093,0.768303964135213 +-141.03494,59.1953773,13.719616,733601.910351684,1094155.7967104,189.944519042969,142,2.27862676625748,0.581206679680868 +-140.97114,59.1889348,13.719616,737305.98914495,1094155.81274766,180.531723022461,142,2.25655352714514,0.501030374895138 +-140.90737,59.1824611,13.719616,741009.751732274,1094155.76939393,174.203521728516,142,2.24105693053273,0.444742312829835 +-140.84362,59.1759561,13.719616,744713.765101044,1094155.76611816,168.013427734375,142,2.22534399218958,0.387668435848418 +-140.77989,59.16942,13.719616,748418.031019335,1094155.82482544,160.863143920898,142,2.20645655233218,0.319063863274258 +-140.71619,59.1628527,13.719616,752121.999206407,1094155.8212944,150,142,2.17609125905568,0.208768450976442 +-140.65252,59.1562542,13.719616,755825.67580924,1094155.75386043,149,142,2.17318626841227,0.198216695792707 +-140.58887,59.1496246,13.719616,759529.623349995,1094155.74619347,138,142,2.13987908640124,0.07723550391239 +-140.52524,59.1429638,13.719616,763233.85018566,1094155.78737314,137,142,2.13672056715641,0.0657628604840208 +-140.46164,59.1362719,13.719616,766937.801559643,1094155.77291468,135,142,2.13033376849501,0.0425641847719837 +-140.39806,59.129549,13.719616,770642.039914113,1094155.8281899,131,142,2.11727129565576,-0.0048824449810836 +-140.33451,59.122795,13.719616,774346.01496575,1094155.82572105,128,142,2.10720996964787,-0.0414280528301153 +-140.27099,59.1160099,13.719616,778049.732795838,1094155.76392036,127,142,2.10380372095596,-0.0538005203193092 +-140.20749,59.1091938,13.719616,781753.755797934,1094155.76986757,129,142,2.11058971029925,-0.0291518701102782 +-140.14402,59.1023467,13.719616,785457.531387212,1094155.72539674,126,142,2.10037054511756,-0.0662707948902998 +-140.08057,59.0954685,13.719616,789161.626545501,1094155.73684962,121,142,2.08278537031645,-0.130145169076543 +-140.01714,59.0885594,13.719616,792866.042657932,1094155.82623159,121,142,2.08278537031645,-0.130145169076543 +-139.95375,59.0816194,13.719616,796569.66846776,1094155.75379224,118,142,2.07188200730613,-0.169749295659684 +-139.89038,59.0746483,13.719616,800273.631919854,1094155.73548927,118,142,2.07188200730613,-0.169749295659684 +-139.82703,59.0676464,13.719616,803977.931951483,1094155.80428079,115,142,2.06069784035361,-0.21037338231028 +-139.76371,59.0606136,13.719616,807682.018258465,1094155.82779877,117.82984161377,142,2.07125529390541,-0.172025697612883 +-139.70042,59.0535498,13.719616,811385.899195569,1094155.79364319,118.966232299805,142,2.07542370755254,-0.156884829462821 +-139.63716,59.0464553,13.719616,815089.573557489,1094155.73311164,119.974807739258,142,2.07909006264408,-0.143567581288405 +-139.57392,59.0393298,13.719616,818793.613087441,1094155.73528051,119.176918029785,142,2.07619215017784,-0.154093626512362 +-139.5107,59.0321735,13.719616,822498.018925612,1094155.82221926,115.688179016113,142,2.06328898513716,-0.200961604870087 +-139.44752,59.0249864,13.719616,826201.679736951,1094155.74535393,113.417335510254,142,2.05467944028038,-0.232233929198673 +-139.38436,59.0177686,13.719616,829905.716232789,1094155.76243128,111.599998474121,142,2.04766418866356,-0.257715325423115 +-139.32123,59.0105199,13.719616,833609.580559854,1094155.72637445,108.179809570312,142,2.03414621261506,-0.306816472845783 +-139.25812,59.0032405,13.719616,837313.832343517,1094155.78368718,104.770431518555,142,2.02023873264557,-0.35733240968494 +-139.19504,58.9959304,13.719616,841017.918816902,1094155.80801736,105.158180236816,142,2.02184306202973,-0.351505027440477 +-139.13199,58.9885895,13.719616,844721.848312187,1094155.78709106,103.973518371582,142,2.01692274036055,-0.369377040142563 +-139.06897,58.981218,13.719616,848425.621720312,1094155.74134932,108.120567321777,142,2.03390831582868,-0.307680581876418 +-139.00597,58.9738157,13.719616,852129.808476726,1094155.77595822,113.759826660156,142,2.05598892163644,-0.227477519150268 +-138.943,58.9663828,13.719616,855833.850795724,1094155.78417909,133.815078735352,142,2.12650505395933,0.0286572007544968 +-138.88006,58.9589193,13.719616,859537.754472433,1094155.76468243,172.81591796875,142,2.23758374258501,0.432126702857188 +-138.81715,58.9514252,13.719616,863241.525295892,1094155.71615158,184.830047607422,142,2.26677257537607,0.538148874876643 +-138.75426,58.9439004,13.719616,866945.73021599,1094155.75693974,178.474456787109,142,2.25157606879441,0.482950825457234 +-138.6914,58.9363451,13.719616,870649.811309185,1094155.77810188,132.730804443359,142,2.12297172653609,0.015823147041222 +-138.62857,58.9287592,13.719616,874353.776879601,1094155.7674719,116.523254394531,142,2.06641260559732,-0.189615723788739 +-138.56577,58.9211428,13.719616,878057.630117187,1094155.73466197,92.5605087280273,40,1.96642573290532,-0.552796584500861 +-138.50299,58.9134959,13.719616,881761.935372682,1094155.81118494,76.7521743774414,40,1.88509068782021,-0.848228683583123 +-138.44025,58.9058185,13.719616,885465.581121065,1094155.73080398,67.2701568603516,40,1.82782244037056,-1.05624330430543 +-138.37753,58.8981105,13.719616,889169.6929293,1094155.74751776,65.7293395996094,40,1.81775926882858,-1.09279561566105 +-138.31484,58.8903722,13.719616,892873.710067061,1094155.75994127,64.4027481079102,40,1.80890439938834,-1.12495902889935 +-138.25218,58.8826034,13.719616,896577.643427367,1094155.74511836,58.5205841064453,40,1.76730865226086,-1.2760466550746 +-138.18954,58.8748041,13.719616,900282.057329961,1094155.83741316,59.9430465698242,40,1.77773881193028,-1.23816133809133 +-138.12694,58.8669745,13.719616,903985.834926074,1094155.78679436,54.9774436950684,40,1.74018454243841,-1.37456916394148 +-138.06437,58.8591145,13.719616,907689.543118108,1094155.71622019,34.7000007629395,40,1.54032948433959,-2.10049977926921 +-138.00182,58.8512241,13.719616,911393.74617635,1094155.76175739,23.7999992370605,40,1.37657694313465,-2.69529574855413 +-152.9365,59.8004527,13.719616,59473.9765453604,1090451.78222434,18.869665145874,32,1.27576419340343,-3.06147643040145 +-152.87028,59.7999058,13.719616,63177.882845777,1090451.7812875,24.0947780609131,32,1.38192293033158,-2.67587759715823 +-152.80406,59.7993258,13.719616,66881.9149328058,1090451.77377117,23.8972816467285,32,1.37834850207915,-2.68886094081442 +-152.73785,59.7987129,13.719616,70585.5205862614,1090451.77173322,28.8385810852051,32,1.45997388843209,-2.39237423937576 +-152.67163,59.7980669,13.719616,74289.8259336577,1090451.77385411,30.0674686431885,32,1.47809686672471,-2.32654640940397 +-152.60542,59.7973879,13.719616,77993.7197628534,1090451.7698611,33.2052574157715,32,1.52120685135143,-2.16995864042507 +-152.53921,59.7966759,13.719616,81697.7686052208,1090451.77076245,33.5894508361816,32,1.52620290349139,-2.15181155303746 +-152.473,59.7959309,13.719616,85401.9798104888,1090451.77695625,67.7759094238281,32,1.83107535369775,-1.04442779462718 +-152.4068,59.7951529,13.719616,89105.8015467118,1090451.77544169,80.088249206543,32,1.90356879974061,-0.781110906909981 +-152.3406,59.7943419,13.719616,92809.8003430454,1090451.77895551,81.2297058105469,32,1.90971488035379,-0.758786587856866 +-152.2744,59.7934978,13.719616,96513.9838374372,1090451.77677209,72.6511993408203,32,1.86124278811513,-0.934851062180238 +-152.20821,59.7926208,13.719616,100217.799625597,1090451.77663095,50.9033966064453,32,1.7067467622625,-1.49602472563303 +-152.14202,59.7917108,13.719616,103921.81451356,1090451.78181802,35.7751884460449,32,1.55358193008693,-2.05236311369024 +-152.07583,59.7907677,13.719616,107626.036170077,1090451.78166381,41.193531036377,32,1.6148290205043,-1.82989619963433 +-152.00965,59.7897917,13.719616,111329.912121294,1090451.78228803,38.6418571472168,32,1.5870579906577,-1.93076850667824 +-151.94347,59.7887826,13.719616,115034.009550089,1090451.77752853,20.5088920593262,32,1.31194219934849,-2.93006758657806 +-149.6967,59.7348719,13.71624392,240969.686133699,1090451.77448294,295.480560302734,33,2.47052891387729,1.27825005416219 +-149.63074,59.7327106,10.5974966,244673.813640688,1090451.77338364,75.1311111450195,33,1.87581981184764,-0.881903151286945 +-149.49885,59.7282897,12.3878695,252081.84494177,1090451.77573564,89.5702743530273,33,1.95216390445699,-0.604599616156291 +-149.43292,59.7260301,13.719616,255785.763146016,1090451.77828744,151.774566650391,133,2.18119900154095,0.227321229577785 +-149.367,59.7237376,13.719616,259489.627028452,1090451.76631292,242.160873413086,133,2.38410397434181,0.964330005635649 +-149.30108,59.7214123,13.719616,263194.002223225,1090451.79019575,219.992660522461,133,2.34240819196873,0.812879022895461 +-149.23518,59.7190542,13.719616,266897.77757671,1090451.77084536,219.761901855469,133,2.3419524048843,0.811223474110241 +-149.16929,59.7166634,13.719616,270601.518663066,1090451.75811958,254.616348266602,133,2.40588628515437,1.04344957579738 +-149.1034,59.7142397,13.719616,274305.793481101,1090451.77066543,175.487152099609,133,2.24424532606399,0.456323475458045 +-149.03752,59.7117833,13.719616,278010.048414588,1090451.79026653,179.580963134766,133,2.25426029645311,0.49270070646847 +-148.97166,59.7092942,13.719616,281713.73144814,1090451.77418582,184.487594604492,133,2.26596716845742,0.535223407062079 +-148.9058,59.7067722,13.719616,285417.969820602,1090451.78410627,182.422348022461,133,2.26107804138444,0.517464702037216 +-148.83996,59.7042176,13.719616,289121.649793087,1090451.76780022,190.028137207031,133,2.27881791110556,0.581900972327241 +-148.77412,59.7016302,13.719616,292825.898610491,1090451.78921798,192.731460571289,133,2.28495261261754,0.604183959236896 +-148.7083,59.69901,13.719616,296529.605099653,1090451.76048782,197.209259033203,133,2.29492730133861,0.640414875731432 +-148.64248,59.6963571,13.719616,300233.893907439,1090451.78127349,197.125137329102,133,2.29474200889245,0.639741840679245 +-148.57668,59.6936715,13.719616,303937.653822345,1090451.76150508,198.494613647461,133,2.29774872623805,0.650663096281069 +-148.51088,59.6909532,13.719616,307642.010353986,1090451.79196399,193.777053833008,133,2.2873023486502,0.612718871188952 +-148.4451,59.6882022,13.719616,311345.852285549,1090451.78038472,172.13981628418,133,2.23588133513011,0.425943073065518 +-148.37933,59.6854185,13.719616,315049.745940337,1090451.7723756,168.411758422852,133,2.22637241044086,0.391403944476844 +-148.31357,59.6826021,13.719616,318753.698457985,1090451.76779644,189.242324829102,133,2.2770182746875,0.575364179189488 +-148.24782,59.679753,13.719616,322457.716975361,1090451.7665247,164.832260131836,133,2.21704221358762,0.35751400640255 +-148.18208,59.6768713,13.719616,326161.807648163,1090451.77959489,86.1016387939453,33,1.93501141756741,-0.666902344346435 +-148.11635,59.6739569,13.719616,329865.978563967,1090451.79577824,70.1549530029297,33,1.84605833802875,-0.990005318967486 +-148.05064,59.6710098,13.719616,333569.67767023,1090451.76477692,53.5041427612305,33,1.72838741022097,-1.41741971539197 +-147.98493,59.6680301,13.719616,337274.029442893,1090451.79757355,64.4294891357422,33,1.80908468781992,-1.12430416985642 +-147.91924,59.6650178,13.719616,340977.922609623,1090451.79311652,76.6072463989258,33,1.8842698521681,-0.851210192961388 +-147.85356,59.6619728,13.719616,344681.924471422,1090451.79047923,79.0935440063477,33,1.89814103574995,-0.800826094962154 +-147.78789,59.6588952,13.719616,348386.04110048,1090451.80079539,111.688812255859,133,2.0480096724989,-0.256460429522247 +-147.72224,59.655785,13.719616,352089.720396491,1090451.77106291,119.307037353516,133,2.07666606138752,-0.152372245731074 +-147.6566,59.6526422,13.719616,355793.528617989,1090451.75321516,119.601066589355,133,2.0777350526608,-0.148489364306022 +-147.59096,59.6494668,13.719616,359498.032020449,1090451.80143386,119.948921203613,133,2.0789963463645,-0.143907985565127 +-147.52535,59.6462588,13.719616,363201.560132511,1090451.75338922,126.662124633789,133,2.10264676861939,-0.058002901432797 +-147.45974,59.6430182,13.719616,366905.797565304,1090451.77156216,126.529663085938,133,2.10219235163326,-0.0596534736299567 +-147.39415,59.6397451,13.719616,370609.631911675,1090451.75724359,133.388702392578,133,2.12511904774891,0.0236228305926711 +-147.32857,59.6364394,13.719616,374313.63050302,1090451.75411325,130.270233154297,133,2.11484519043476,-0.0136947516231429 +-147.263,59.6331012,13.719616,378017.799265702,1090451.77343207,169.905883789062,133,2.23020841861523,0.405337421071911 +-147.19745,59.6297305,13.719616,381721.586041374,1090451.75787153,202.325500488281,230,2.30605062337093,0.680817956265021 +-147.13191,59.6263272,13.719616,385425.558184677,1090451.75283978,199.3857421875,230,2.29969409925808,0.657729246354529 +-147.06638,59.6228914,13.719616,389129.721579229,1090451.76964608,202.304672241211,230,2.30600591294947,0.680655555252665 +-147.00087,59.6194231,13.719616,392833.524056811,1090451.74934037,212.309143066406,230,2.32696869740569,0.756798371772022 +-146.93537,59.6159223,13.719616,396537.531807716,1090451.750178,169.750793457031,140,2.22981181295669,0.403896836117561 +-146.86988,59.612389,13.719616,400241.751837934,1090451.77239504,123.031997680664,140,2.09001807573961,-0.103873918559952 +-146.80441,59.6088232,13.719616,403945.631969097,1090451.75541968,115.553871154785,140,2.0627844993002,-0.202794041424504 +-146.73895,59.605225,13.719616,407649.737161114,1090451.77034714,111.575691223145,140,2.0475695860209,-0.258058949223529 +-146.67351,59.6015943,13.719616,411353.516426955,1090451.7444066,114.749938964844,140,2.0597524632094,-0.213807261935566 +-146.60808,59.5979312,13.719616,415057.53469767,1090451.74984044,107.386199951172,140,2.03094847437905,-0.318431570844318 +-146.54266,59.5942356,13.719616,418761.800182051,1090451.77585492,107.688415527344,140,2.03216898701992,-0.313998320563678 +-146.47726,59.5905076,13.719616,422465.759420297,1090451.77028515,102.965614318848,140,2.01269221494935,-0.3847435159482 +-146.41187,59.5867472,13.719616,426169.978542019,1090451.79598121,97.6712188720703,41,1.98976660745986,-0.468015865969897 +-146.3465,59.5829544,13.719616,429873.905311347,1090451.78858256,100.689666748047,41,2.00298490347746,-0.420003241956648 +-146.28115,59.5791292,13.719616,433577.546669711,1090451.74680166,105.009712219238,140,2.0212294682905,-0.353733775038449 +-146.2158,59.5752716,13.719616,437282.027916762,1090451.80105726,113.548332214355,140,2.05518075973214,-0.230412993859063 +-146.15048,59.5713817,13.719616,440985.677125185,1090451.76533847,117.922119140625,140,2.07159527515211,-0.17079078868459 +-146.08517,59.5674594,13.719616,444689.620883951,1090451.75954907,151.752975463867,140,2.18113721516654,0.227096803830336 +-146.01987,59.5635047,13.719616,448393.866119678,1090451.78414211,157.413558959961,140,2.19704213798413,0.284868023220777 +-145.95459,59.5595177,13.719616,452097.859222934,1090451.78261172,155.85710144043,140,2.19272659516678,0.269192739929612 +-145.88933,59.5554984,13.719616,455801.607080017,1090451.75376735,170.317520141602,140,2.23125932505862,0.409154613232848 +-145.82408,59.5514468,13.719616,459505.675754348,1090451.76562628,188.506301879883,140,2.27532587351216,0.569216895061264 +-145.75885,59.5473628,13.719616,463209.514327643,1090451.73785991,248.573577880859,241,2.39545496344325,1.00556003794692 +-145.69363,59.5432466,13.719616,466913.686098436,1090451.76182735,277.923767089844,241,2.44392568774394,1.18161954352914 +-145.62843,59.5390981,13.719616,470617.640129763,1090451.75611646,176.113693237305,241,2.24579312465667,0.461945521732385 +-145.56324,59.5349173,13.719616,474321.942469462,1090451.79104216,155.78955078125,140,2.19253832502956,0.268508889053555 +-145.49807,59.5307043,13.719616,478026.039371964,1090451.80629745,151.999069213867,140,2.18184092849399,0.229652891495422 +-145.43292,59.526459,13.719616,481729.939102032,1090451.78971525,152.542938232422,140,2.1833921073722,0.235287215931627 +-145.36779,59.5221815,13.719616,485433.647065266,1090451.75132548,140.169036865234,140,2.14665208921062,0.101836983323555 +-145.30267,59.5178718,13.719616,489137.729260875,1090451.76373595,124.210647583008,140,2.09415882602046,-0.0888335316521371 +-145.23757,59.5135299,13.719616,492841.633322126,1090451.75338031,128.955657958984,140,2.1104404016617,-0.0296942016987867 +-145.17248,59.5091558,13.719616,496545.925240073,1090451.79401474,142.245330810547,140,2.15303801962602,0.125032505318269 +-145.10741,59.5047495,13.719616,500250.052639781,1090451.81099026,168.470474243164,140,2.22652379840109,0.391953828758822 +-145.04236,59.500311,13.719616,503954.022323103,1090451.80332735,227.989044189453,140,2.35791397786718,0.869200463070586 +-144.97733,59.4958404,13.719616,507657.839573249,1090451.78114136,287.317169189453,241,2.45836157886854,1.23405482050724 +-144.91232,59.4913376,13.719616,511361.51267647,1090451.732404,368.442108154297,341,2.56636925858782,1.62636954170867 +-144.84732,59.4868027,13.719616,515065.606066813,1090451.74481745,442.869018554688,341,2.64627529974431,1.91661109064388 +-144.78234,59.4822357,13.719616,518769.567315824,1090451.7410212,548.209838867188,341,2.73894682567153,2.25322052389844 +-142.13474,59.2675035,13.719616,670633.677029502,1090451.7523552,684.260681152344,440,2.83522158537236,2.6029179306841 +-142.0706,59.2616002,13.719616,674337.871557511,1090451.79147416,560.474304199219,440,2.74855570649335,2.28812272169095 +-142.00649,59.2556654,13.719616,678041.646144403,1090451.75331327,530.674987792969,341,2.72482861858947,2.20193916603891 +-141.9424,59.2496991,13.719616,681745.566320417,1090451.7385874,491.280090332031,241,2.69132916422816,2.08025958610243 +-141.87833,59.2437013,13.719616,685449.638429583,1090451.74704394,404.053894042969,241,2.6064392966067,1.77191535692076 +-141.81428,59.2376721,13.719616,689153.866770659,1090451.78943757,325.626342773438,241,2.51271953153156,1.43149841988369 +-141.75026,59.2316115,13.719616,692857.69846434,1090451.76121039,231.423278808594,241,2.36440704238421,0.892785126701552 +-141.68626,59.2255194,13.719616,696561.701049018,1090451.75437242,211.253341674805,340,2.32480358748895,0.748934074570522 +-141.62228,59.219396,13.719616,700265.876703962,1090451.79070276,225.551284790039,340,2.35324530527827,0.852242511655806 +-141.55833,59.2132412,13.719616,703969.67458439,1090451.75302344,272.882965087891,340,2.43597642537586,1.1527455536629 +-141.4944,59.207055,13.719616,707673.660151454,1090451.74604993,323.402282714844,340,2.50974308102172,1.42068710206838 +-141.43049,59.2008375,13.719616,711377.837576534,1090451.78060611,342.107421875,340,2.53416249612132,1.50938538770513 +-141.36661,59.1945887,13.719616,715081.653916368,1090451.7488687,350.218170166016,340,2.54433867458045,1.5463481724392 +-141.30275,59.1883086,13.719616,718785.674584154,1090451.75726347,347.724639892578,240,2.54123546603625,1.53507643326276 +-141.23891,59.1819971,13.719616,722489.907941753,1090451.79469678,324.420471191406,240,2.5111082507332,1.42564578811872 +-141.1751,59.1756544,13.719616,726193.796769953,1090451.77366558,261.230590820312,142,2.41702403265873,1.08390505376285 +-141.11131,59.1692805,13.719616,729897.906433883,1090451.80230558,203.854446411133,142,2.30932018859053,0.692693950369426 +-141.04755,59.1628753,13.719616,733601.686097981,1090451.75910213,191.162445068359,142,2.28140257673945,0.59128921564657 +-140.98381,59.1564388,13.719616,737305.701147917,1090451.75334117,182.325286865234,142,2.26084690554172,0.516625150683706 +-140.92009,59.1499712,13.719616,741009.95340748,1090451.80690176,174.952987670898,142,2.24292136332596,0.451514464896953 +-140.8564,59.1434724,13.719616,744713.892024446,1090451.79663849,167.193130493164,142,2.22321842950132,0.379947785468638 +-140.79274,59.1369424,13.719616,748417.52315528,1090451.72085179,161.479507446289,142,2.20811741603129,0.325096594287117 +-140.72909,59.1303813,13.719616,752121.969093525,1090451.81531825,152,142,2.18184358794477,0.229662551379749 +-140.66548,59.123789,13.719616,755825.560639789,1090451.72932058,147,142,2.16731733474818,0.176899053564259 +-140.60188,59.1171656,13.719616,759529.979236287,1090451.81358479,141,142,2.14921911265538,0.111161145176344 +-140.53832,59.1105111,13.719616,763233.553442661,1090451.72503001,141,142,2.14921911265538,0.111161145176344 +-140.47477,59.1038255,13.719616,766937.9668985,1090451.80679713,136,142,2.13353890837022,0.0542061676367513 +-140.41126,59.0971089,13.719616,770641.545880507,1090451.72343287,135,142,2.13033376849501,0.0425641847719837 +-140.34776,59.0903612,13.719616,774345.976267502,1090451.81050153,133,142,2.12385164096709,0.0190192474071795 +-140.2843,59.0835825,13.719616,778049.584303831,1090451.72922655,133,142,2.12385164096709,0.0190192474071795 +-140.22085,59.0767728,13.719616,781754.053574839,1090451.82949018,129,142,2.11058971029925,-0.0291518701102782 +-140.15744,59.0699321,13.719616,785457.712574491,1090451.75824835,128,142,2.10720996964787,-0.0414280528301153 +-140.09405,59.0630604,13.719616,789161.68569566,1090451.74992718,125,142,2.09691001300806,-0.0788404352462293 +-140.03068,59.0561578,13.719616,792865.976629341,1090451.81558592,124,142,2.09342168516224,-0.0915110376501457 +-139.96734,59.0492242,13.719616,796570.034527335,1090451.82448183,123,142,2.0899051114394,-0.10428423714156 +-139.90403,59.0422597,13.719616,800273.863048162,1090451.78602349,127,142,2.10380372095596,-0.0538005203193092 +-139.84074,59.0352644,13.719616,803978.024983779,1090451.83068469,124,142,2.09342168516224,-0.0915110376501457 +-139.77748,59.0282381,13.719616,807681.971844338,1090451.81516623,121,142,2.08278537031645,-0.130145169076543 +-139.71425,59.021181,13.719616,811385.704853308,1090451.75983156,121,142,2.08278537031645,-0.130145169076543 +-139.65104,59.014093,13.719616,815089.791515912,1090451.77501595,119.691184997559,142,2.07806216671478,-0.147301192694335 +-139.58786,59.0069742,13.719616,818793.676197156,1090451.74855805,120.166458129883,142,2.07978326066211,-0.141049688228506 +-139.5247,58.9998246,13.719616,822497.923993845,1090451.80285424,116.899490356445,142,2.06781261778403,-0.184530479923345 +-139.46157,58.9926442,13.719616,826201.981634981,1090451.81373052,113.227821350098,142,2.05395315100669,-0.234872019144303 +-139.39847,58.9854331,13.719616,829905.852586476,1090451.79066984,113.400001525879,142,2.05461306040063,-0.232475039868605 +-139.3354,58.9781912,13.719616,833609.545163725,1090451.72134425,110.435134887695,142,2.04310726596824,-0.274267369327741 +-139.27235,58.9709186,13.719616,837313.62198093,1090451.7413387,110.221122741699,142,2.04226483055119,-0.277327335217468 +-139.20933,58.9636152,13.719616,841017.532181278,1090451.71339117,105.051445007324,142,2.02140203060576,-0.353106979455237 +-139.14633,58.9562812,13.719616,844721.835866827,1090451.78512364,106.052680969238,142,2.02552165178166,-0.338143339487406 +-139.08336,58.9489165,13.719616,848425.982158405,1090451.81818224,115.047943115234,142,2.06087885853974,-0.209715872590517 +-139.02042,58.9415212,13.719616,852129.974392877,1090451.8221068,122.332618713379,142,2.08754227255905,-0.112866742376332 +-138.95751,58.9340952,13.719616,855833.820880592,1090451.78465456,156.903686523438,142,2.19563314765308,0.27975016817251 +-138.89463,58.9266386,13.719616,859537.524925666,1090451.71538634,187.108444213867,142,2.27209338767496,0.557475583857239 +-138.83177,58.9191514,13.719616,863241.651496862,1090451.74296259,191.309753417969,142,2.28173711193856,0.592504342975584 +-138.76894,58.9116336,13.719616,866945.647194971,1090451.73720281,171.794631958008,142,2.23500958937044,0.422776643645371 +-138.70614,58.9040853,13.719616,870649.515244051,1090451.70769153,133.548187255859,142,2.12563799741078,0.025507803887557 +-138.64336,58.8965065,13.719616,874353.820563704,1090451.78479334,117.491554260254,142,2.07000664899076,-0.176561132341643 +-138.58061,58.8888971,13.719616,878058.012277644,1090451.82580696,92.2422027587891,40,1.96492966543327,-0.55823072857952 +-138.5179,58.8812573,13.719616,881761.531797408,1090451.71844992,77.7381896972656,40,1.89063442292192,-0.828092255354163 +-138.4552,58.8735869,13.719616,885466.067540528,1090451.83803281,73.0022048950195,40,1.86333597737086,-0.927248001347733 +-138.39254,58.8658861,13.719616,889169.94250329,1090451.80674165,71.0944519042969,40,1.85183571041523,-0.969020253433553 +-138.32991,58.8581549,13.719616,892873.721543784,1090451.75611185,68.4583358764648,40,1.83542633785689,-1.02862377826668 +-138.2673,58.8503933,13.719616,896577.969513923,1090451.81992222,63.8717613220215,40,1.8053088923892,-1.13801893658009 +-138.20473,58.8426013,13.719616,900281.573716621,1090451.72750872,59.5804977416992,40,1.77510412703563,-1.24773126564263 +-138.14218,58.8347789,13.719616,903985.658172315,1090451.74823694,71.1899261474609,40,1.85241854239947,-0.966903241309982 +-138.07966,58.8269261,13.719616,907689.669352398,1090451.74591412,56.6650390625,40,1.75331519248814,-1.32687489510018 +-138.01717,58.819043,13.719616,911393.610238743,1090451.7302197,39.6797676086426,40,1.59856911996955,-1.8889567994142 +-137.9547,58.8111296,10.30008399,915098.045621496,1090451.83777507,11.3149137496948,40,1.05365124780251,-3.86825404617039 +-152.93756,59.7673345,13.719616,59473.9495961254,1086747.78248337,23.7971382141113,32,1.37652473299986,-2.69548539066594 +-152.87141,59.7667881,13.719616,63177.629131546,1086747.77332465,29.9172401428223,32,1.47592152749368,-2.33444786239468 +-152.80525,59.7662087,13.719616,66881.9938148852,1086747.77474464,31.2172679901123,32,1.49439489268105,-2.26734732721081 +-152.7391,59.7655964,13.719616,70585.9313050648,1086747.7786636,32.1128807067871,32,1.50667926598213,-2.22272697707206 +-152.67295,59.7649511,13.719616,74290.008878771,1086747.78375562,34.3270721435547,32,1.53563676275801,-2.11754508348961 +-152.60681,59.7642728,13.719616,77993.6741446627,1086747.77863697,35.2373390197754,32,1.54700310482906,-2.07625928481051 +-152.54066,59.7635615,13.719616,81698.053926762,1086747.78661693,33.1547698974609,32,1.52054601814428,-2.172358975254 +-152.47452,59.7628172,13.719616,85402.0360936852,1086747.78404678,81.6974334716797,32,1.91220841336724,-0.749729364226843 +-152.40839,59.7620399,13.719616,89105.6279906595,1086747.76966888,87.505126953125,32,1.94203349921913,-0.641396139485751 +-152.34225,59.7612297,13.719616,92809.9561603786,1086747.78137333,78.1525344848633,32,1.89294306674346,-0.819706602041775 +-152.27612,59.7603865,13.719616,96513.9087259945,1086747.78104038,61.7284774780273,32,1.79048556530267,-1.19186149155715 +-152.20999,59.7595103,13.719616,100218.052768998,1086747.78255809,46.768985748291,32,1.66995795171956,-1.62965218609692 +-152.14387,59.7586012,13.719616,103921.835580159,1086747.78194558,31.175407409668,32,1.49381213767952,-2.2694640597112 +-152.07775,59.757659,13.719616,107625.824853071,1086747.77188624,31.2396335601807,32,1.49470593097591,-2.26621754734468 +-152.01163,59.756684,13.719616,111330.026956946,1086747.78643983,28.3527050018311,32,1.45259449925458,-2.41917828715583 +-151.94552,59.7556759,13.719616,115033.890463144,1086747.77529512,12.1377658843994,32,1.08413875647839,-3.75751471265828 +-151.08648,59.7395736,13.40703577,163185.688523488,1086747.7768077,33.1949272155762,32,1.52107172073386,-2.1704494733982 +-150.22841,59.7179096,5.114550228,211337.736173528,1086747.77424537,134.277648925781,33,2.12800372855826,0.0341008146621167 +-149.8987,59.7080986,10.95167231,229857.910258128,1086747.78572694,124.512580871582,33,2.09521323518326,-0.0850036166144983 +-149.83278,59.7060379,10.13697716,233562.043923576,1086747.79191426,55.6432151794434,33,1.74541221647364,-1.35558075971878 +-149.70097,59.7018181,12.70253595,240970.019466957,1086747.78951961,155.935592651367,33,2.19294525520054,0.269986975584017 +-149.63508,59.699659,13.1417458,244673.875783039,1086747.77992679,293.808990478516,33,2.4680650809555,1.26930070974229 +-149.5692,59.6974671,13.08684336,248377.654083937,1086747.76409298,50.635814666748,33,1.70445780162513,-1.50433888400237 +-149.50332,59.6952424,13.29359146,252081.921322052,1086747.77951535,102.663665771484,33,2.01141676738534,-0.389376305549692 +-149.43746,59.692985,13.719616,255785.564463907,1086747.76154939,151.109756469727,133,2.17929250566381,0.220396292383903 +-149.3716,59.6906948,13.719616,259489.710941663,1086747.77508603,224.205917358398,133,2.35064707053454,0.842804981456574 +-149.30575,59.6883718,13.719616,263193.808223675,1086747.78176054,215.892517089844,133,2.33423758979644,0.783201063683693 +-149.23991,59.686016,13.719616,266897.863514676,1086747.78118382,207.432662963867,133,2.31687714273807,0.720142964802748 +-149.17408,59.6836275,13.719616,270601.883205195,1086747.7841375,215.842071533203,133,2.33413610046683,0.782832425470597 +-149.10826,59.6812062,13.719616,274305.87528505,1086747.77911369,172.152572631836,133,2.23591351714503,0.426059967329377 +-149.04245,59.6787522,13.719616,278009.846117917,1086747.77692803,179.192810058594,133,2.25332058002185,0.489287388168396 +-148.97665,59.6762655,13.719616,281713.80286589,1086747.77726021,176.615631103516,133,2.24702913752915,0.466435073278436 +-148.91086,59.673746,13.719616,285417.753544689,1086747.76865819,178.22216796875,133,2.25096172230316,0.480719343649058 +-148.84508,59.6711939,13.719616,289121.703610387,1086747.77313702,181.519668579102,133,2.25892368993727,0.509639482667959 +-148.77931,59.668609,13.719616,292825.661940831,1086747.76813146,189.447601318359,133,2.27748911084725,0.57707439051171 +-148.71355,59.6659914,13.719616,296529.634832075,1086747.76454165,187.416915893555,133,2.2728087869129,0.560074118084709 +-148.6478,59.6633411,13.719616,300233.629433671,1086747.76213588,189.393341064453,133,2.27736470544972,0.576622514599038 +-148.58206,59.6606581,13.719616,303937.652892567,1086747.76070016,204.387619018555,133,2.31045458444322,0.696814399895209 +-148.51633,59.6579425,13.719616,307641.711430797,1086747.77118228,212.563003540039,133,2.32748767807727,0.758683457703054 +-148.45061,59.6551942,13.719616,311345.813090245,1086747.78225751,198.830642700195,133,2.29848331632929,0.653331337165326 +-148.3849,59.6524132,13.719616,315049.965009878,1086747.79376474,183.23664855957,133,2.26301233983077,0.524490626098021 +-148.31921,59.6495995,13.719616,318753.614587255,1086747.75756335,197.344833374023,133,2.29522576074661,0.641498965490108 +-148.25352,59.6467532,13.719616,322457.887466822,1086747.7801043,197.071533203125,133,2.2946238953821,0.639312818696703 +-148.18785,59.6438743,13.719616,326161.67126887,1086747.76472443,133.505264282227,33,2.12549839082154,0.0250007129077736 +-148.12219,59.6409627,13.719616,329865.533815307,1086747.74818867,81.0712661743164,33,1.90886695589904,-0.76186649149825 +-148.05653,59.6380186,13.719616,333570.039971002,1086747.80292666,71.9026107788086,33,1.85674465987168,-0.95118954785404 +-147.9909,59.6350418,13.719616,337273.519596873,1086747.75591968,70.4212417602539,33,1.84770367885503,-0.984028971459423 +-147.92527,59.6320324,13.719616,340977.658006752,1086747.76894903,76.5748138427734,33,1.88408594968815,-0.851878179259574 +-147.85965,59.6289903,13.719616,344681.903577675,1086747.78062846,116.361793518066,133,2.0658104065334,-0.19180308267363 +-147.79405,59.6259158,13.719616,348385.700554011,1086747.77189569,113.567321777344,133,2.05525338407391,-0.230149201520691 +-147.72846,59.6228086,13.719616,352089.61884904,1086747.76070214,116.453453063965,133,2.06615237071004,-0.190560971177754 +-147.66288,59.6196688,13.719616,355793.664504641,1086747.75821059,118.94361114502,133,2.0753411196059,-0.157184812457942 +-147.59731,59.6164965,13.719616,359497.843515664,1086747.77559699,121.672668457031,133,2.08519303286132,-0.121399851498256 +-147.53176,59.6132917,13.719616,363201.603178636,1086747.7582313,126.306365966797,133,2.10142523998192,-0.0624398421030535 +-147.46622,59.6100543,13.719616,366905.511362698,1086747.74863721,128.233901977539,133,2.10800285743971,-0.0385480580574318 +-147.40069,59.6067844,13.719616,370609.574020423,1086747.75803936,137.003860473633,133,2.1367328048117,0.0658073111410103 +-147.33517,59.6034819,13.719616,374313.799297928,1086747.77542369,143.93830871582,133,2.15817639539398,0.143696552745968 +-147.26967,59.6001469,13.719616,378017.633380775,1086747.75512633,188.863021850586,133,2.27614693421457,0.572199221886467 +-147.20418,59.5967795,13.719616,381721.641884765,1086747.7642224,201.005615234375,230,2.30320818991422,0.670493426638982 +-147.1387,59.5933795,13.719616,385425.834099569,1086747.78062716,200.713882446289,230,2.30257741165695,0.668202259966547 +-147.07324,59.589947,13.719616,389129.656168063,1086747.75705171,207.089630126953,230,2.31615835243572,0.717532113261433 +-147.00779,59.5864821,13.719616,392833.67366331,1086747.7622925,213.483474731445,230,2.32936426291744,0.765499749473175 +-146.94235,59.5829847,13.719616,396537.894744719,1086747.78544203,189.134643554688,140,2.2767710853052,0.574466316798115 +-146.87693,59.5794549,13.719616,400241.765479384,1086747.77758261,131.193771362305,140,2.11791321669213,-0.00255080455449815 +-146.81152,59.5758926,13.719616,403945.853780534,1086747.78699514,127.827209472656,140,2.10662330817338,-0.0435589747553109 +-146.74613,59.5722978,13.719616,407649.606905477,1086747.75256297,120.234703063965,140,2.08002983517064,-0.140154059234149 +-146.68075,59.5686707,13.719616,411353.589125644,1086747.75706472,120.699996948242,140,2.08170725911672,-0.134061176677526 +-146.61538,59.5650111,13.719616,415057.809846057,1086747.77856765,118.865882873535,140,2.07505722042236,-0.158216015325476 +-146.55003,59.5613191,13.719616,418761.715061795,1086747.76544459,105.627380371094,140,2.02377650913297,-0.344482195700778 +-146.48469,59.5575947,13.719616,422465.871460694,1086747.77996656,80.956916809082,140,1.90825395999103,-0.764093067602581 +-146.41937,59.553838,13.719616,426169.724976067,1086747.76941855,56.8712730407715,41,1.75489294986979,-1.32114402995324 +-146.35406,59.5500489,13.71563788,429873.843540338,1086747.78610933,46.1245002746582,41,1.66393167392844,-1.65154134710522 +-146.28877,59.5462274,13.719616,433577.674353209,1086747.76513313,70.8299255371094,41,1.85021678522858,-0.974900651798715 +-146.22349,59.5423735,13.719616,437281.784088074,1086747.77105954,102.638694763184,140,2.01131112056142,-0.389760044968747 +-146.15823,59.5384874,13.719616,440985.617302748,1086747.76010882,117.664817810059,140,2.07064662669198,-0.174236550663008 +-146.09298,59.5345688,13.719616,444689.744582304,1086747.7646841,150.047668457031,140,2.17622925144956,0.20926967873795 +-146.02775,59.530618,13.719616,448393.609127129,1086747.75102369,160.551254272461,140,2.20561370274887,0.316002393014456 +-145.96253,59.5266349,13.719616,452097.778880281,1086747.77488744,166.115417480469,140,2.22040994199963,0.369746557240358 +-145.89733,59.5226195,13.719616,455801.700986406,1086747.76811997,206.966079711914,140,2.31589917347112,0.716590701284974 +-145.83214,59.5185718,13.719616,459505.942063697,1086747.79873394,396.119262695312,341,2.5978259620177,1.74062926720307 +-145.63668,59.5062351,13.719616,470617.846357667,1086747.78792561,490.096740722656,440,2.69028181434517,2.07645531238398 +-145.57156,59.5020583,13.719616,474321.751384378,1086747.76737925,215.684982299805,341,2.33381990712674,0.781683921008832 +-145.50645,59.4978494,13.719616,478026.006847531,1086747.80576871,168.45735168457,241,2.22648996887233,0.391830950254458 +-145.44136,59.4936082,13.719616,481730.06267332,1086747.80896459,172.482864379883,140,2.23674595578661,0.429083622077221 +-145.37629,59.4893349,13.719616,485433.922817999,1086747.79807931,190.182495117188,140,2.27917054086708,0.583181824271637 +-145.31124,59.4850293,13.719616,489137.596981879,1086747.74988654,295.706115722656,140,2.47086030659286,1.27945376709404 +-145.2462,59.4806916,13.719616,492841.648808369,1086747.75973663,171.771926879883,140,2.2349521874499,0.422568143485832 +-145.18118,59.4763217,13.719616,496545.526813948,1086747.74242958,181.254440307617,140,2.25828865456703,0.507332852946134 +-145.11617,59.4719196,13.719616,500249.797540462,1086747.77229071,234.80989074707,140,2.37071638646998,0.915702465287143 +-145.05118,59.4674855,13.719616,503953.905043997,1086747.79628479,496.842468261719,140,2.69621871064567,2.09801981430631 +-144.98621,59.4630191,13.719616,507657.860593285,1086747.78019895,643.844665527344,341,2.80878110176741,2.50687854736556 +-144.92126,59.4585207,13.719616,511361.66644011,1086747.75631694,615.29541015625,440,2.7890836754468,2.43533187276389 +-141.82615,59.2050976,13.719616,689153.971134248,1086747.80737382,572.743469238281,241,2.75796014580566,2.32228232956746 +-141.76219,59.1990427,13.719616,692857.777210444,1086747.76991569,408.403717041016,241,2.61108968611579,1.7888068989711 +-141.69825,59.1929565,13.719616,696561.747121198,1086747.77208171,242.924621582031,241,2.38547153487635,0.96929737583774 +-141.63433,59.1868388,13.719616,700265.891263149,1086747.7916858,223.897125244141,241,2.35004851743512,0.840630865755407 +-141.57044,59.1806898,13.719616,703969.652052416,1086747.7445095,275.579681396484,340,2.44024719370479,1.16825820323223 +-141.50657,59.1745095,13.719616,707673.595474211,1086747.73525556,328.205078125,340,2.51614529635329,1.44394177552682 +-141.44272,59.1682979,13.719616,711377.727769704,1086747.76375476,345.890533447266,340,2.53893867612863,1.52673383674918 +-141.37889,59.162055,13.719616,715082.055174655,1086747.82985228,353.727416992188,340,2.54866872276911,1.56207614337919 +-141.31509,59.1557808,13.719616,718786.024180738,1086747.82517475,339.94189453125,340,2.5314046904511,1.49936825035478 +-141.25132,59.1494753,13.719616,722489.641012836,1086747.74792281,307.341613769531,240,2.48762136730784,1.34033472369386 +-141.18756,59.1431386,13.719616,726194.029224211,1086747.82598038,248.396713256836,142,2.39514584503166,1.00443723164487 +-141.12384,59.1367706,13.719616,729897.517935224,1086747.72022835,200.285629272461,142,2.30164978927575,0.664832870708237 +-141.06013,59.1303715,13.719616,733601.788241224,1086747.78056459,192.471282958984,142,2.2843659412066,0.602053001219686 +-140.99645,59.1239411,13.719616,737305.731154773,1086747.76460538,186.101531982422,142,2.26974994824508,0.548963542963711 +-140.93279,59.1174796,13.719616,741009.908240768,1086747.8041295,176.169616699219,142,2.24593100942406,0.46244635856376 +-140.86916,59.1109869,13.719616,744713.76808534,1086747.77598453,169.683929443359,142,2.2296407127681,0.403275351395745 +-140.80555,59.104463,13.719616,748417.876581835,1086747.79115878,163,142,2.21218760440396,0.339880680204086 +-140.74197,59.097908,13.719616,752121.677923621,1086747.74733799,159,142,2.20139712432045,0.300686576631144 +-140.67841,59.091322,13.719616,755825.735733866,1086747.76760279,150,142,2.17609125905568,0.208768450976442 +-140.61487,59.0847048,13.719616,759530.060563492,1086747.83004273,149,142,2.17318626841227,0.198216695792707 +-140.55137,59.0780566,13.719616,763233.534570416,1086747.72673087,148,142,2.17026171539496,0.187593884483276 +-140.48788,59.0713773,13.719616,766937.845293256,1086747.78984588,145,142,2.16136800223497,0.155289379767752 +-140.42442,59.0646669,13.719616,770641.879344064,1086747.78902242,138,142,2.13987908640124,0.07723550391239 +-140.36099,59.0579256,13.719616,774345.638246916,1086747.74453352,142,142,2.15228834438306,0.122309470857218 +-140.29758,59.0511532,13.719616,778049.692336276,1086747.75003657,139,142,2.14301480025409,0.0886253116478125 +-140.23419,59.0443499,13.719616,781754.043083016,1086747.8274964,138,142,2.13987908640124,0.07723550391239 +-140.17084,59.0375156,13.719616,785457.579324765,1086747.72951647,133,142,2.12385164096709,0.0190192474071795 +-140.1075,59.0306504,13.719616,789161.983985424,1086747.82028108,130,142,2.11394335230684,-0.0169704851139895 +-140.0442,59.0237542,13.719616,792865.58617327,1086747.73248006,129,142,2.11058971029925,-0.0291518701102782 +-139.98091,59.0168271,13.719616,796570.068779798,1086747.83366674,129,142,2.11058971029925,-0.0291518701102782 +-139.91766,59.0098691,13.719616,800273.758569754,1086747.76414459,125,142,2.09691001300806,-0.0788404352462293 +-139.85443,59.0028803,13.719616,803977.778632283,1086747.77376819,125,142,2.09691001300806,-0.0788404352462293 +-139.79123,58.9958606,13.719616,807681.577540175,1086747.73015455,127,142,2.10380372095596,-0.0538005203193092 +-139.72805,58.9888101,13.719616,811385.718611446,1086747.76490826,119,142,2.07554696139253,-0.156437136335818 +-139.6649,58.9817287,13.719616,815089.650427929,1086747.74456219,124.05192565918,142,2.09360351021778,-0.0908505971503743 +-139.60177,58.9746165,13.719616,818793.936275108,1086747.80185841,122.500198364258,142,2.08813679195306,-0.110707278244557 +-139.53867,58.9674736,13.719616,822498.019913724,1086747.82407491,120.409614562988,142,2.08066116619872,-0.137860884740346 +-139.4756,58.9602999,13.719616,826201.909646601,1086747.79884512,117.455390930176,142,2.06987295468108,-0.177046748234552 +-139.41256,58.9530955,13.719616,829905.608940602,1086747.73564502,117.210182189941,142,2.06896534100651,-0.180343460159322 +-139.34954,58.9458603,13.719616,833609.685846081,1086747.74766174,118.769805908203,142,2.07470604675506,-0.159491578320048 +-139.28655,58.9385945,13.719616,837313.581602212,1086747.7308908,116.005905151367,142,2.06448009706639,-0.196635146365913 +-139.22358,58.9312979,13.719616,841017.866703813,1086747.78875567,111.801071166992,142,2.04844596454938,-0.254875692264766 +-139.16064,58.9239707,13.719616,844721.982336762,1086747.81615297,110.480155944824,142,2.04328427858586,-0.273624408976115 +-139.09773,58.9166129,13.719616,848425.934311782,1086747.81169964,111.51685333252,142,2.04734050645333,-0.258891031598771 +-139.03485,58.9092244,13.719616,852129.730931257,1086747.7631299,136.204284667969,142,2.13419076967946,0.056573913971665 +-138.97199,58.9018053,13.719616,855833.935255505,1086747.80885618,170.746078491211,142,2.23235073806845,0.413118936804825 +-138.90916,58.8943556,13.719616,859537.993338491,1086747.81978037,203.50944519043,142,2.30858457031255,0.690021974817469 +-138.84636,58.8868754,13.719616,863241.908438256,1086747.8054593,205.134918212891,142,2.31203959257911,0.702571601851118 +-138.78359,58.8793646,13.719616,866945.68884329,1086747.75368083,163.700805664062,142,2.21405081682548,0.346648399532812 +-138.72084,58.8718233,13.719616,870649.897517587,1086747.80512249,125.572654724121,142,2.09889507574352,-0.0716301207977157 +-138.65812,58.8642514,13.719616,874353.983019346,1086747.81761777,116.957695007324,143,2.06802880065804,-0.183745242020209 +-138.59543,58.8566491,13.719616,878057.945971479,1086747.81164308,101.245040893555,143,2.00537376013057,-0.411326232745012 +-138.53277,58.8490163,13.719616,881761.794648363,1086747.7750393,82.7123870849609,40,1.91757055477377,-0.730252536130787 +-138.47014,58.8413531,13.719616,885465.532178991,1086747.71741707,79.1602249145508,40,1.89850701947839,-0.799496737598302 +-138.40753,58.8336594,13.719616,889169.726584649,1086747.76053605,74.4520263671875,40,1.87187652247922,-0.896226303799891 +-138.34495,58.8259353,13.719616,892873.82122286,1086747.78125349,68.0009689331055,40,1.83251510093128,-1.03919822173023 +-138.2824,58.8181808,13.719616,896577.821763529,1086747.7783363,71.3919982910156,40,1.85364953820759,-0.962431913173722 +-138.21988,58.810396,13.719616,900281.731239343,1086747.76142731,78.805419921875,40,1.89655608755576,-0.806583079192707 +-138.15739,58.8025808,13.719616,903985.557918429,1086747.71844948,81.3956298828125,40,1.91060108832006,-0.755567627574445 +-138.09492,58.7947353,13.719616,907689.864539325,1086747.79574274,76.2306289672852,40,1.8821295030823,-0.85898455175747 +-138.03249,58.7868594,13.719616,911393.539900785,1086747.70846237,69.5,40,1.84198480459011,-1.00480155511883 +-137.97008,58.7789533,13.59791608,915097.703775316,1086747.75105634,46.4247817993164,40,1.66674987119317,-1.64130485024612 +-153.00471,59.7347288,10.95307073,55769.9171031083,1083043.78334216,12.7484664916992,32,1.10545794678978,-3.68007732834457 +-152.93862,59.7342159,13.719616,59473.8044797449,1083043.77815275,23.805326461792,32,1.37667414168462,-2.69494269567742 +-152.87253,59.7336701,13.719616,63177.8095545818,1083043.78136329,30.1259994506836,32,1.47894146383908,-2.32347859161255 +-152.80644,59.7330913,13.719616,66881.9398405812,1083043.78209699,31.6814041137695,32,1.50080442119235,-2.24406609019616 +-152.74036,59.7324795,13.719616,70585.6423861334,1083043.77004811,34.3377227783203,32,1.53577149007933,-2.11705571540355 +-152.67427,59.7318348,13.719616,74290.0449050541,1083043.77743775,34.8459281921387,32,1.54215203732643,-2.09387974661258 +-152.60819,59.7311572,13.719616,77994.0341147061,1083043.7828099,35.1164474487305,32,1.54551057410617,-2.08168058240674 +-152.54212,59.7304466,13.719616,81697.6175700836,1083043.77368875,36.5234642028809,32,1.56257196308033,-2.01970874784734 +-152.47604,59.729703,13.719616,85401.9232062095,1083043.77451661,78.7322845458984,32,1.89615285338896,-0.808047740781015 +-152.40997,59.7289265,13.719616,89105.837504011,1083043.77172607,79.9427795410156,32,1.90277924422856,-0.783978797891346 +-152.3439,59.7281171,13.719616,92809.9280672256,1083043.77805123,72.3860321044922,32,1.85965477109794,-0.940619193251824 +-152.27784,59.7272747,13.719616,96513.6421959206,1083043.76823105,53.4335784912109,32,1.72781426021968,-1.41950155978996 +-152.21178,59.7263994,13.719616,100217.547224496,1083043.76733104,41.0442543029785,32,1.61325236975849,-1.83562304516402 +-152.14572,59.7254912,13.719616,103921.650457785,1083043.77583834,31.8957042694092,32,1.50373219598143,-2.23343157649212 +-152.07966,59.72455,13.719616,107625.959523029,1083043.78308051,40.8131866455078,32,1.61080050529839,-1.8445289167149 +-152.01361,59.7235759,13.719616,111329.921125738,1083043.78399603,28.9162082672119,32,1.4611413440655,-2.38813370729021 +-151.94757,59.7225688,13.719616,115033.542913494,1083043.7662765,17.1740264892578,32,1.23487212842002,-3.21000808217856 +-151.15536,59.7079171,13.719616,159481.706616417,1083043.77635532,55.731388092041,32,1.74609986008843,-1.35308304183684 +-149.90277,59.6750382,12.18778174,229858.034480436,1083043.79546248,186.814605712891,33,2.27141082763573,0.554996330972741 +-149.70524,59.6687638,12.97975198,240969.878307304,1083043.77653573,205.163558959961,33,2.31210022413941,0.702791832984109 +-149.63941,59.6666069,11.15712734,244674.015976074,1083043.79489062,72.9423294067383,33,1.8629796283545,-0.928542362687287 +-149.5736,59.6644171,13.58746237,248377.514787863,1083043.75536507,280.451965332031,133,2.44785848777526,1.19590459577577 +-149.50778,59.6621946,13.719616,252082.061363617,1083043.79201163,283.659332275391,133,2.45279707624563,1.21384295871366 +-149.44198,59.6599394,13.719616,255785.981988913,1083043.79218249,233.205642700195,133,2.36773905450855,0.90488794578808 +-149.37619,59.6576514,13.719616,259489.8449107,1083043.78169269,227.805252075195,133,2.35756373256565,0.867928272165463 +-149.31041,59.6553307,13.719616,263193.656543506,1083043.77128694,217.10400390625,133,2.33666783293556,0.79202840042542 +-149.24463,59.6529772,13.719616,266897.985151835,1083043.78960614,207.791976928711,133,2.31762877496873,0.722873107601698 +-149.17887,59.650591,13.719616,270601.71653069,1083043.76760922,198.865921020508,133,2.29856036592579,0.653611203291971 +-149.11311,59.6481721,13.719616,274305.978436306,1083043.78587276,201.593170166016,133,2.30447581443293,0.67509780070698 +-149.04737,59.6457205,13.719616,278009.657436895,1083043.76200507,180.06672668457,133,2.25543346988616,0.496962007234351 +-148.98163,59.6432362,13.719616,281713.88128391,1083043.7788491,176.095275878906,133,2.24574770527311,0.461780545567307 +-148.91591,59.6407192,13.719616,285417.536540711,1083043.75181768,177.419677734375,133,2.2490017860567,0.473600295780438 +-148.85019,59.6381696,13.719616,289121.750087605,1083043.77716869,179.561050415039,133,2.25421213731839,0.492525778745208 +-148.78448,59.6355872,13.719616,292825.97050085,1083043.78991429,185.748657226562,133,2.26892568293758,0.545969576098132 +-148.71879,59.6329722,13.719616,296529.642889203,1083043.7674476,129.353302001953,133,2.11177751943002,-0.0248374083128444 +-148.6531,59.6303245,13.719616,300233.895857861,1083043.78712878,92.1612701416016,33,1.96454845144901,-0.559615406579636 +-148.58743,59.6276441,13.719616,303937.615957521,1083043.75888162,98.5634460449219,133,1.99371587919668,-0.453670983787381 +-148.52176,59.6249311,13.719616,307641.930000544,1083043.78462517,174.289566040039,133,2.24127138856226,0.445521285605489 +-148.45611,59.6221855,13.719616,311345.724499289,1083043.77208469,199.198577880859,133,2.29928623358216,0.656247761803137 +-148.39047,59.6194072,13.719616,315049.567796074,1083043.75571692,198.793411254883,133,2.29840198618269,0.653035922858943 +-148.32483,59.6165963,13.719616,318754.026365747,1083043.79451341,195.005767822266,133,2.29004745698476,0.622689888192011 +-148.25921,59.6137528,13.719616,322457.986712535,1083043.79290558,203.621292114258,133,2.30882318900973,0.690888706034178 +-148.1936,59.6108767,13.719616,326162.016227135,1083043.79821818,197.72216796875,133,2.29605536373342,0.644512320330473 +-148.12801,59.607968,13.719616,329865.561704621,1083043.76068373,152.290267944336,133,2.18267215078766,0.232672128120498 +-148.06242,59.6050266,13.719616,333569.751824883,1083043.76786806,89.3659057617188,33,1.95117186148373,-0.60820299939244 +-147.99684,59.6020527,13.719616,337274.031391457,1083043.79287213,118.039985656738,33,2.07202914805598,-0.169214838458055 +-147.93128,59.5990463,13.719616,340977.847157837,1083043.78430455,118.874954223633,133,2.07509036270738,-0.158095633086511 +-147.86573,59.5960072,13.719616,344681.768530207,1083043.7700943,118.890327453613,133,2.07514652321082,-0.157891642108241 +-147.80019,59.5929356,13.719616,348385.80053379,1083043.77250105,117.98664855957,133,2.07183286506062,-0.169927794321969 +-147.73466,59.5898315,13.719616,352089.950209643,1083043.79152903,120.126914978027,133,2.07964032394621,-0.141568875178874 +-147.66915,59.5866948,13.719616,355793.665363758,1083043.76249417,119.796745300293,133,2.0784450190773,-0.145910563636727 +-147.60365,59.5835256,13.719616,359497.51228519,1083043.74902763,116.489852905273,133,2.06628809687127,-0.190067975020081 +-147.53815,59.5803239,13.719616,363202.058302303,1083043.80587554,117.08797454834,133,2.06851229340302,-0.181989058367885 +-147.47268,59.5770896,13.719616,366905.630651986,1083043.75791346,125.642036437988,133,2.09913496693861,-0.0707587675053806 +-147.40721,59.5738229,13.719616,370609.915065648,1083043.79155894,133.107055664062,133,2.12420107692286,0.0202884985375042 +-147.34176,59.5705236,13.719616,374313.800178528,1083043.77361196,141.45817565918,133,2.1506280528256,0.116278818026147 +-147.27632,59.5671919,13.719616,378017.851079,1083043.78169787,200.381103515625,230,2.30185676397249,0.66558466188323 +-147.2109,59.5638277,13.719616,381721.515595051,1083043.74735346,202.399444580078,230,2.30620931638842,0.681394374600056 +-147.14548,59.560431,13.719616,385425.921332432,1083043.78513772,198.850158691406,230,2.29852594190875,0.653486165436457 +-147.08008,59.5570019,13.719616,389129.953544938,1083043.79083337,208.574462890625,230,2.31926113388627,0.728802301111826 +-147.0147,59.5535404,13.719616,392833.619206062,1083043.76295745,207.858352661133,230,2.31776748105178,0.723376927685998 +-146.94932,59.5500464,13.719616,396538.047063707,1083043.8083444,204.353454589844,230,2.31038198384661,0.696550693806056 +-146.88397,59.5465199,13.719616,400241.563228277,1083043.74809327,123.317932128906,140,2.09102623359798,-0.100212001461483 +-146.81862,59.5429611,13.719616,403945.853171674,1083043.78381075,115.112365722656,140,2.0611219793783,-0.208832788311277 +-146.75329,59.5393698,13.719616,407649.805663718,1083043.77242873,120.234161376953,140,2.08002787856241,-0.140161166193727 +-146.68797,59.5357462,13.719616,411353.985532884,1083043.7967216,119.088500976562,140,2.07586982862364,-0.155264390396953 +-146.62267,59.5320902,13.719616,415057.840642649,1083043.78336692,117.428680419922,140,2.06977418061611,-0.177405523831453 +-146.55738,59.5284018,13.719616,418761.938239031,1083043.79405677,107.351547241211,140,2.03080830823643,-0.318940694281721 +-146.49211,59.524681,13.719616,422465.724971678,1083043.76550359,77.8162384033203,41,1.89107023340469,-0.826509267288051 +-146.42685,59.5209279,13.719616,426169.76680718,1083043.77165778,54.4982833862305,41,1.73638282287061,-1.38837809453052 +-146.36161,59.5171425,13.719616,429873.5103553,1083043.74814628,43.8899078369141,41,1.64236466888412,-1.72987886526227 +-146.29638,59.5133247,13.719616,433577.524109186,1083043.74784934,35.2519607543945,41,1.54718327795526,-2.07560484458962 +-146.23116,59.5094746,13.719616,437281.81369544,1083043.78226577,63.1260223388672,41,1.8002084246718,-1.15654529114812 +-146.16596,59.5055922,13.719616,440985.825712921,1083043.78539968,96.8563232421875,41,1.98612797879335,-0.481232403854663 +-146.10078,59.5016774,13.719616,444689.568380073,1083043.7448986,135.068969726562,140,2.13055558718337,0.0433698935614611 +-146.03561,59.4977304,13.719616,448393.606238366,1083043.74925371,157.08576965332,140,2.19613684423183,0.281579737915851 +-145.97045,59.4937512,13.719616,452097.946139239,1083043.79891779,156.628173828125,140,2.19486988439854,0.276977778175007 +-145.90531,59.4897396,13.719616,455802.037353,1083043.80352969,171.112823486328,341,2.23328255752862,0.416503571051926 +-145.84019,59.4856958,13.719616,459505.884048037,1083043.7841047,519.946411132812,341,2.71595858488746,2.16972067187354 +-145.51482,59.4649935,13.719616,478025.615358572,1083043.75662371,381.673278808594,440,2.58169175577776,1.68202522497865 +-145.44979,59.4607564,13.719616,481729.820804454,1083043.77940656,236.593872070312,341,2.37400349193809,0.927642170580652 +-145.38478,59.4564872,13.719616,485433.828105563,1083043.78474229,642.783447265625,241,2.8080646844358,2.50427631513128 +-145.25481,59.4478522,13.719616,492841.840090215,1083043.77980845,608.786743164062,341,2.78446518674317,2.41855620354437 +-145.18985,59.4434865,13.719616,496545.856907693,1083043.77967648,614.378540039062,440,2.7884360375811,2.4329794671814 +-141.7741,59.1664724,13.719616,692857.688052793,1083043.76050881,682.523193359375,341,2.83411741406715,2.5989072653417 +-141.71022,59.1603918,13.719616,696561.625187281,1083043.73882664,499.919281005859,241,2.69889988704859,2.10775861228565 +-141.64636,59.15428,13.719616,700265.727432495,1083043.76379423,339.1201171875,241,2.53035355363647,1.49555022141972 +-141.58252,59.1481368,13.719616,703970.005163145,1083043.8132311,286.691833496094,241,2.45741532211252,1.23061774588081 +-141.51871,59.1419623,13.719616,707673.902270289,1083043.79137633,327.301422119141,340,2.51494789231428,1.43959246228401 +-141.45492,59.1357566,13.719616,711377.983190243,1083043.81447911,348.16748046875,340,2.54178820471205,1.5370841379006 +-141.39116,59.1295195,13.719616,715081.698048502,1083043.75273919,350.052001953125,340,2.54413256573231,1.54559952627344 +-141.32742,59.1232513,13.719616,718785.607040366,1083043.74550536,322.744201660156,340,2.50885844858488,1.41747386455854 +-141.2637,59.1169517,13.719616,722489.722718347,1083043.75970856,298.07568359375,240,2.4743265486197,1.2920441474995 +-141.2,59.110621,13.719616,726194.044907277,1083043.82815408,257.115966796875,240,2.41012904699083,1.05886049779219 +-141.13633,59.104259,13.719616,729898.023763558,1083043.81887811,200.26692199707,142,2.30160922298075,0.664685522346012 +-141.07269,59.0978659,13.719616,733601.661168856,1083043.75205404,191.867050170898,142,2.28300039861442,0.597092960760241 +-141.00907,59.0914416,13.719616,737305.525730524,1083043.72597538,187.057067871094,142,2.27197412247501,0.557042378609335 +-140.94547,59.0849861,13.719616,741009.623612555,1083043.74057398,182.425567626953,142,2.26108570625742,0.517492543043645 +-140.88189,59.0784995,13.719616,744713.958779474,1083043.80675773,174.860778808594,142,2.24269240835136,0.450682835078961 +-140.81834,59.0719818,13.719616,748417.977056282,1083043.81178542,179,142,2.25285303097989,0.487589116596209 +-140.75482,59.065433,13.719616,752121.684558839,1083043.75395135,168,142,2.22530928172586,0.387542357536829 +-140.69132,59.0588531,13.719616,755825.647693819,1083043.74537403,159,142,2.20139712432045,0.300686576631144 +-140.62784,59.0522422,13.719616,759529.870330082,1083043.79700215,156,142,2.19312459835446,0.27063840110868 +-140.56439,59.0456002,13.719616,763233.800485112,1083043.78296156,155,142,2.19033169817029,0.260493790466696 +-140.50096,59.0389271,13.719616,766938.00454871,1083043.81708557,148,142,2.17026171539496,0.187593884483276 +-140.43756,59.0322231,13.719616,770641.92377785,1083043.80526343,151,142,2.17897694729317,0.219250094312423 +-140.37419,59.025488,13.719616,774345.568747071,1083043.72397024,144,142,2.15836249209525,0.14437250908227 +-140.31083,59.018722,13.719616,778050.061549459,1083043.82779522,146,142,2.16435285578444,0.166131219821422 +-140.24751,59.0119251,13.719616,781753.72730377,1083043.76533311,145,142,2.16136800223497,0.155289379767752 +-140.18421,59.0050972,13.719616,785457.694913976,1083043.75892228,142,142,2.15228834438306,0.122309470857218 +-140.12093,58.9982383,13.719616,789161.970407883,1083043.80866139,139,142,2.14301480025409,0.0886253116478125 +-140.05768,58.9913486,13.719616,792865.99485174,1083043.8171418,139,142,2.14301480025409,0.0886253116478125 +-139.99446,58.984428,13.719616,796569.776539439,1083043.7718714,134,142,2.12710479836481,0.0308356436192711 +-139.93126,58.9774765,13.719616,800273.881746625,1083043.79181255,135,142,2.13033376849501,0.0425641847719837 +-139.86809,58.9704942,13.719616,803977.753789458,1083043.76697686,127,142,2.10380372095596,-0.0538005203193092 +-139.80494,58.9634811,13.719616,807681.958900793,1083043.81746211,132,142,2.12057393120585,0.00711367000286348 +-139.74182,58.9564371,13.719616,811385.945096442,1083043.8103358,125,142,2.09691001300806,-0.0788404352462293 +-139.67873,58.9493623,13.719616,815089.715940307,1083043.75503033,128.525894165039,142,2.10899063397141,-0.034960171754807 +-139.61566,58.9422568,13.719616,818793.835245362,1083043.78427397,127.317977905273,142,2.10488973243439,-0.0498558166510915 +-139.55262,58.9351205,13.719616,822497.751009809,1083043.76350079,124.086799621582,142,2.09372558362261,-0.0904071917007971 +-139.4896,58.9279535,13.719616,826202.02701414,1083043.82657626,124.214363098145,142,2.09417181688411,-0.0887863451273707 +-139.42662,58.9207558,13.719616,829905.548535682,1083043.72379523,125.028053283691,142,2.09700746916306,-0.0784864466745124 +-139.36365,58.9135273,13.719616,833610.004771606,1083043.81770956,121.971908569336,142,2.08625981954272,-0.117524977780206 +-139.30072,58.9062682,13.719616,837313.715813893,1083043.7538203,119.101684570312,142,2.0759179041731,-0.155089766279186 +-139.23781,58.8989785,13.719616,841017.808076716,1083043.78231446,115.220512390137,142,2.06152980221939,-0.207351459348203 +-139.17493,58.8916581,13.719616,844721.729553737,1083043.76536513,115.091979980469,142,2.06104506149617,-0.209112176013733 +-139.11207,58.884307,13.719616,848426.046381723,1083043.82934282,110.483779907227,142,2.04329852404966,-0.273572665385552 +-139.04925,58.8769254,13.719616,852129.638811665,1083043.73971961,135.496795654297,142,2.13192902475941,0.0483586108557784 +-138.98645,58.8695132,13.719616,855833.635708477,1083043.7402952,183.350296020508,142,2.26328161546907,0.525468712075276 +-138.92367,58.8620704,13.719616,859538.042863549,1083043.83139098,205.615768432617,240,2.31305641713588,0.706264998871947 +-138.86093,58.8545971,13.719616,863241.742943292,1083043.76426057,214.868392944336,143,2.33217253564307,0.775700197573494 +-138.79821,58.8470933,13.719616,866945.862288991,1083043.79698196,169.108825683594,143,2.22816627374595,0.397919768020505 +-138.73552,58.8395589,13.719616,870649.848893284,1083043.78792343,124.347671508789,143,2.09463765723481,-0.0870942800095793 +-138.67286,58.8319941,13.719616,874353.703409466,1083043.75754691,114.770805358887,143,2.05983142914201,-0.213520435129186 +-138.61022,58.8243988,13.719616,878057.99440056,1083043.82588601,112.796890258789,143,2.05229712657937,-0.240887172540744 +-138.54762,58.816773,13.719616,881761.606997864,1083043.72778414,105.434356689453,143,2.022982152521,-0.347367525647409 +-138.48504,58.8091169,13.719616,885465.66233691,1083043.74870769,91.6604995727539,40,1.96218221992927,-0.56821023484906 +-138.42249,58.8014303,13.719616,889169.610967455,1083043.73342506,81.284309387207,40,1.91000672020402,-0.757726542221433 +-138.35996,58.7937133,13.719616,892874.016283506,1083043.8260062,71.8467864990234,40,1.85640734815637,-0.952414760282416 +-138.29747,58.785966,13.719616,896577.760742772,1083043.76774151,74.1515426635742,40,1.87012019060794,-0.902605802463392 +-138.235,58.7781883,13.719616,900281.973198613,1083043.81598203,86.2598190307617,40,1.93580854268051,-0.664006958413493 +-138.17257,58.7703803,13.719616,903985.536075968,1083043.70980683,89.4945297241211,40,1.95179649025185,-0.605934169419835 +-138.11016,58.762542,13.719616,907689.575587339,1083043.7196864,88.7280426025391,40,1.94806090081013,-0.61950289651553 +-138.04778,58.7546734,13.719616,911393.53704978,1083043.70885959,84.0853424072266,40,1.92472029702911,-0.704282631519787 +-137.98542,58.7467746,13.719616,915097.983697695,1083043.82478629,73.226921081543,40,1.86467077406028,-0.92239963878282 +-137.9231,58.7388455,13.719616,918801.803188187,1083043.78040454,54.3437156677246,40,1.7351493293123,-1.39285849520843 +-137.86081,58.7308862,13.17842996,922505.558722845,1083043.72263561,23.5329265594482,40,1.37167593948311,-2.71309759270222 +-153.0057,59.7016093,13.58385229,55769.8954414222,1079339.77992709,19.2054824829102,32,1.28342522204706,-3.0336493876925 +-152.93968,59.7010969,13.719616,59473.5411771692,1079339.77041542,29.4314708709717,32,1.46881196699884,-2.36027181538257 +-152.87365,59.7005516,13.719616,63177.8652935817,1079339.77471148,35.2171058654785,32,1.54675366286643,-2.07716532921662 +-152.80763,59.6999734,13.719616,66881.7533906034,1079339.77465002,35.7987022399902,32,1.55386728306212,-2.05132663023652 +-152.74161,59.6993623,13.719616,70585.773630068,1079339.77950805,34.1601753234863,32,1.53352009099318,-2.12523343949774 +-152.67559,59.6987182,13.719616,74289.9335420552,1079339.77844521,35.7000007629395,32,1.55266822539344,-2.05568194993431 +-152.60958,59.6980412,13.719616,77993.6793781004,1079339.77125624,35.1615829467773,32,1.54606841843745,-2.0796543325709 +-152.54357,59.6973313,13.719616,81697.5792981404,1079339.76894623,69.8664016723633,32,1.84426837637187,-0.996506970611231 +-152.47756,59.6965885,13.719616,85401.6406072665,1079339.77190991,78.4301834106445,32,1.89448323061812,-0.814112287242489 +-152.41155,59.6958128,13.719616,89105.8706098366,1079339.7805603,75.4019012451172,32,1.87738229666358,-0.876227760457874 +-152.34555,59.6950041,13.719616,92809.7160338441,1079339.7701747,62.8657684326172,32,1.7984142284715,-1.1630623238622 +-152.27955,59.6941626,13.719616,96513.7444902469,1079339.77642038,50.4317321777344,32,1.70270388511952,-1.51070960936835 +-152.21355,59.6932881,13.719616,100217.963849221,1079339.77740759,42.2423439025879,32,1.62574800790924,-1.7902353207903 +-152.14756,59.6923808,13.719616,103921.819967288,1079339.78033114,32.3375816345215,32,1.50970753807953,-2.21172742845939 +-152.08157,59.6914405,13.719616,107625.881611454,1079339.77787176,34.3249168395996,32,1.5356094937268,-2.11764413239429 +-152.01559,59.6904673,13.719616,111329.594926074,1079339.76496663,26.5053081512451,32,1.42333285770817,-2.52546492135643 +-151.94961,59.6894613,13.719616,115033.527718422,1079339.7689819,31.2909641265869,32,1.49541894468681,-2.26362767803233 +-151.88363,59.6884223,13.719616,118737.687965098,1079339.76812218,13.7854843139648,32,1.13942202841696,-3.55671008956062 +-151.22411,59.6762245,13.719616,155777.674817846,1079339.77532561,40.5030555725098,32,1.60748778786216,-1.85656165198699 +-151.15818,59.6748239,12.76808755,159482.008798205,1079339.78371947,51.4038925170898,32,1.71099600682962,-1.48059025651009 +-150.30173,59.6536291,6.764854621,207633.684241504,1079339.7753706,117.022186279297,33,2.06826820760281,-0.182875647663269 +-149.97263,59.6440011,11.70986876,226154.019203014,1079339.78839184,69.0989532470703,33,1.83947146846733,-1.01393070929433 +-149.90684,59.6419772,13.719616,229857.706977004,1079339.76839143,201.158340454102,33,2.30353804405667,0.671691551034093 +-149.84105,59.6399206,12.47137681,233561.845551204,1079339.78212655,129.857559204102,33,2.11346723563706,-0.0186998767558495 +-149.77527,59.6378312,9.062929068,237265.881964242,1079339.78384461,86.2560119628906,33,1.93578937471709,-0.664076581927715 +-149.7095,59.635709,13.28376135,240969.823429133,1079339.77302615,206.770141601562,33,2.31548782516706,0.715096566834148 +-149.64374,59.6335542,12.34005379,244673.675690837,1079339.77148582,65.8456497192383,33,1.81852708734125,-1.09000667966581 +-149.57798,59.6313666,13.12917062,248378.008234051,1079339.79382087,77.189094543457,133,1.88755594652547,-0.839274160310734 +-149.51224,59.6291462,13.719616,252081.706557112,1079339.76532296,255.81819152832,133,2.4079314244251,1.05087810536951 +-149.4465,59.6268932,13.719616,255785.898040548,1079339.78321367,247.324295043945,133,2.39326677986828,0.99761193063285 +-149.38077,59.6246074,13.719616,259490.030520477,1079339.78734796,234.621871948242,133,2.37036849551891,0.914438826054921 +-149.31506,59.622289,13.719616,263193.548766359,1079339.7599909,222.537551879883,133,2.34740330609517,0.831022703150222 +-149.24935,59.6199378,13.719616,266897.583216399,1079339.75714046,211.65234375,133,2.32562308203307,0.751910712661798 +-149.18365,59.617554,13.719616,270601.578591323,1079339.76165183,200.071960449219,133,2.3011862276894,0.663149082712968 +-149.11796,59.6151375,13.719616,274305.542839249,1079339.76200914,189.862014770508,133,2.27843808519154,0.58052133619441 +-149.05227,59.6126883,13.719616,278010.043971896,1079339.79973051,178.452743530273,133,2.251523229181,0.482758896899411 +-148.9866,59.6102064,13.719616,281713.967436119,1079339.79132356,173.83869934082,133,2.24014646393823,0.44143523828557 +-148.92094,59.6076918,13.719616,285417.881238801,1079339.77778402,172.009246826172,133,2.2355517942194,0.424746086417478 +-148.85529,59.6051447,13.719616,289121.790799438,1079339.78111811,177.013702392578,133,2.24800688581466,0.46998653412854 +-148.78965,59.6025648,13.719616,292825.705828879,1079339.76760455,120.413146972656,133,2.08067390673884,-0.137814607462142 +-148.72402,59.5999523,13.719616,296529.631730587,1079339.7592839,91.9032974243164,33,1.9633310938398,-0.564037196884736 +-148.6584,59.5973072,13.719616,300233.575614201,1079339.7559156,89.4548263549805,33,1.95160377701955,-0.606634158885368 +-148.59279,59.5946295,13.719616,303937.544586779,1079339.75727658,91.4012222290039,33,1.96095200321483,-0.572678733094721 +-148.52719,59.5919191,13.719616,307641.546673216,1079339.75201734,104.971153259277,133,2.02106996857905,-0.354313123516195 +-148.4616,59.5891762,13.719616,311345.587145432,1079339.76223888,171.706985473633,133,2.23478796371619,0.421971636010903 +-148.39602,59.5864006,13.719616,315049.674954456,1079339.76548365,193.829681396484,133,2.28742028189788,0.613147238406029 +-148.33045,59.5835924,13.719616,318753.816276261,1079339.77274273,198.246429443359,133,2.29720537411317,0.648689486275348 +-148.26489,59.5807517,13.719616,322458.017240093,1079339.79502095,197.4833984375,133,2.29553059226612,0.642606200576526 +-148.19935,59.5778784,13.719616,326161.72502518,1079339.77194553,205.553741455078,133,2.31292538614437,0.705789056910831 +-148.13381,59.5749725,13.719616,329866.068427955,1079339.80108335,216.86360168457,133,2.33618666628788,0.790280665822401 +-148.06829,59.572034,13.719616,333569.932825422,1079339.78356837,206.014572143555,133,2.31389794064929,0.709321652467369 +-148.00278,59.569063,13.719616,337273.885145765,1079339.77958378,128.750854492188,133,2.10975012004341,-0.0322015015624155 +-147.93728,59.5660595,13.719616,340977.932435592,1079339.78907828,116.50724029541,133,2.06635291525592,-0.18983253614601 +-147.8718,59.5630234,13.719616,344681.521914813,1079339.74898227,115.181541442871,133,2.06138288627631,-0.207885099987462 +-147.80632,59.5599548,13.719616,348385.781324086,1079339.77366021,117.060852050781,133,2.06841168088875,-0.182354511737354 +-147.74086,59.5568537,13.719616,352089.59599289,1079339.75875246,113.634078979492,133,2.05550859627998,-0.229222197943429 +-147.67541,59.5537201,13.719616,355793.533810171,1079339.75617821,114.062973022461,133,2.05714468717213,-0.223279448836311 +-147.60997,59.5505539,13.719616,359497.602881931,1079339.75484253,108.519012451172,133,2.03550583292444,-0.301877943807811 +-147.54454,59.5473553,13.719616,363201.808099346,1079339.77705906,110.340049743652,133,2.042733175411,-0.275626173007725 +-147.47913,59.5441242,13.719616,366905.596697153,1079339.75651862,110.447463989258,133,2.04315574838205,-0.274091267362529 +-147.41373,59.5408606,13.719616,370609.53655199,1079339.7474403,112.785820007324,133,2.05225450142319,-0.241041999274422 +-147.34834,59.5375646,13.719616,374313.633565115,1079339.76105382,130.617446899414,133,2.11600119061496,-0.00949582901334152 +-147.28296,59.5342361,13.719616,378017.895848864,1079339.7863525,206.253295898438,230,2.31440089724168,0.711148534369055 +-147.2176,59.5308752,13.719616,381721.768422054,1079339.7771195,213.609680175781,230,2.32962092977818,0.766432036771394 +-147.15225,59.5274818,13.719616,385425.820266635,1079339.77874776,215.311996459961,230,2.33306822792483,0.778953607596882 +-147.08691,59.524056,13.719616,389130.057227188,1079339.80253106,218.932418823242,230,2.34031007528918,0.805258064253243 +-147.02159,59.5205978,13.719616,392833.925419883,1079339.78950372,214.476577758789,230,2.33137987132016,0.772821014503786 +-146.95628,59.5171072,13.719616,396537.992665885,1079339.79790543,209.03857421875,230,2.32022643455394,0.732308548661051 +-146.89099,59.5135842,13.719616,400241.705074705,1079339.76768907,168.160522460938,140,2.22572404800356,0.389048907043519 +-146.82571,59.5100288,13.719616,403945.630460781,1079339.75824379,106.512840270996,140,2.02740196573439,-0.33131350251606 +-146.76044,59.506441,13.719616,407649.775780994,1079339.76982381,99.2505569458008,140,1.99673295249117,-0.442712112423353 +-146.69519,59.5028209,13.719616,411353.585907209,1079339.75187379,94.9803009033203,140,1.97763354111928,-0.512086626040777 +-146.62995,59.4991684,13.719616,415057.629849152,1079339.75439044,93.4946746826172,140,1.97078687481029,-0.536955672308161 +-146.56472,59.4954836,13.719616,418761.91330406,1079339.78879034,89.1650543212891,41,1.95019467848957,-0.611752406943023 +-146.49951,59.4917664,13.719616,422465.883588183,1079339.78066759,39.6504516601562,41,1.59824813875063,-1.89012269481847 +-146.43432,59.488017,13.719616,426169.545098798,1079339.7509058,70.3483200073242,41,1.84725373048063,-0.985663312383282 +-146.36913,59.4842352,13.719616,429874.028978574,1079339.80542273,21.7262725830078,41,1.33698522399719,-2.83910417306308 +-146.30397,59.4804211,13.42476201,433577.658304427,1079339.76150953,17.6883106231689,41,1.24768635625223,-3.16346314914721 +-146.23882,59.4765747,13.719616,437281.561680562,1079339.74789458,32.9931526184082,41,1.51842381598068,-2.180067419249 +-146.17368,59.472696,13.719616,440985.745999234,1079339.76497998,63.8646469116211,41,1.80526051543505,-1.13819465548572 +-146.10856,59.4687851,13.719616,444689.655969322,1079339.75732692,98.0900650024414,140,1.99162502233289,-0.461265572706643 +-146.04345,59.4648419,13.719616,448393.860633607,1079339.78011044,123.602554321289,140,2.09202744580278,-0.0965753129592073 +-145.97836,59.4608665,13.719616,452097.80467176,1079339.77680694,150.908630371094,341,2.17871407751823,0.218295276259338 +-145.91328,59.4568588,13.719616,455802.057140826,1079339.80374288,282.397247314453,341,2.45086045908667,1.20680861242674 +-145.84822,59.452819,13.719616,459506.061322139,1079339.81440696,581.738586425781,341,2.76472787128678,2.34686464021608 +-145.4582,59.4279036,13.719616,481729.775839608,1079339.77487096,635.893981933594,440,2.80338471486347,2.48727732984827 +-141.65836,59.1217195,13.719616,700265.951171836,1079339.80288399,593.967102050781,440,2.77376239145683,2.37968059618249 +-141.59459,59.1155821,13.719616,703969.618996048,1079339.73760032,391.250915527344,341,2.59245536680501,1.72112173247006 +-141.53083,59.1094135,13.719616,707674.022302592,1079339.82023807,349.633239746094,341,2.54361271444313,1.54371127801081 +-141.4671,59.1032136,13.719616,711378.047686083,1079339.82706622,343.103210449219,341,2.53542478180976,1.51397036961776 +-141.4034,59.0969824,13.719616,715081.701378409,1079339.7562435,330.772430419922,340,2.51952930434041,1.4562334584281 +-141.33972,59.09072,13.719616,718785.548341898,1079339.72515274,299.990173339844,340,2.47710702893907,1.30214364564753 +-141.27606,59.0844264,13.719616,722489.594766049,1079339.73364831,269.526519775391,240,2.43060150356904,1.13322230350512 +-141.21242,59.0781016,13.719616,726193.846834943,1079339.78159877,255.898544311523,240,2.40806781539375,1.0513735162975 +-141.14881,59.0717457,13.719616,729897.747723225,1079339.76995149,210.052337646484,240,2.32232751911048,0.73994028747964 +-141.08522,59.0653585,13.719616,733601.86874737,1079339.78545054,193.462341308594,240,2.28659643936232,0.610154807168824 +-141.02166,59.0589403,13.719616,737305.648739925,1079339.74989105,185.129196166992,142,2.26747491542672,0.540699974408415 +-140.95812,59.0524909,13.719616,741009.659016879,1079339.75116284,185.324234008789,142,2.26793221375024,0.54236101244538 +-140.8946,59.0460104,13.719616,744713.903543083,1079339.80016727,182,142,2.26007138798507,0.513808249563239 +-140.83111,59.0394988,13.719616,748417.827584033,1079339.78415631,182,142,2.26007138798507,0.513808249563239 +-140.76764,59.0329561,13.719616,752121.998107963,1079339.81466999,181,142,2.25767857486918,0.505116869349467 +-140.7042,59.0263824,13.719616,755825.858146064,1079339.78882843,176,142,2.24551266781415,0.460926822429992 +-140.64078,59.0197776,13.719616,759529.976857652,1079339.80835485,177,142,2.24797326636181,0.46986441867983 +-140.57739,59.0131419,13.719616,763233.794997722,1079339.78022872,171,142,2.23299611039215,0.415463113292133 +-140.51402,59.0064751,13.719616,766937.883958459,1079339.79636491,163,142,2.21218760440396,0.339880680204086 +-140.45068,58.9997773,13.719616,770641.686706756,1079339.75169923,162,142,2.20951501454263,0.330173070994654 +-140.38736,58.9930486,13.719616,774345.767870415,1079339.7721393,162,142,2.20951501454263,0.330173070994654 +-140.32407,58.9862889,13.719616,778049.574893146,1079339.72963005,157,142,2.19589965240923,0.280718189514898 +-140.2608,58.9794983,13.719616,781753.672370542,1079339.75121743,152,142,2.18184358794477,0.229662551379749 +-140.19755,58.9726768,13.719616,785458.066303275,1079339.83697289,154,142,2.18752072083646,0.250283518457422 +-140.13434,58.9658244,13.719616,789161.640978024,1079339.74932152,151,142,2.17897694729317,0.219250094312423 +-140.07115,58.9589411,13.719616,792865.524092316,1079339.72379061,147,142,2.16731733474818,0.176899053564259 +-140.00798,58.9520269,13.719616,796569.721629618,1079339.76049206,147,142,2.16731733474818,0.176899053564259 +-139.94484,58.9450819,13.719616,800273.676365266,1079339.74997728,148,142,2.17026171539496,0.187593884483276 +-139.88172,58.9381061,13.719616,803977.955094154,1079339.81176587,148,142,2.17026171539496,0.187593884483276 +-139.81863,58.9310995,13.719616,807682.002897082,1079339.82438454,144,142,2.15836249209525,0.14437250908227 +-139.75557,58.9240621,13.719616,811385.825703183,1079339.78631872,136,142,2.13353890837022,0.0542061676367513 +-139.69253,58.9169939,13.719616,815089.990289902,1079339.81880114,137.814224243164,142,2.13929404479588,0.0751104658142197 +-139.62952,58.909895,13.719616,818793.939320519,1079339.80964278,137.107604980469,142,2.13706154457399,0.0670013877893375 +-139.56654,58.9027653,13.719616,822497.681085905,1079339.74644655,134.819580078125,142,2.12975297011002,0.0404545592613433 +-139.50358,58.895605,13.719616,826201.777504504,1079339.77398395,133.478454589844,142,2.12541116976139,0.0246839011219093 +-139.44065,58.8884139,13.719616,829905.678421954,1079339.74567937,127.943305969238,142,2.10701756840474,-0.0421269090619377 +-139.37774,58.8811922,13.719616,833609.945703558,1079339.80743664,125.747352600098,142,2.09949885048127,-0.0694370386157375 +-139.31486,58.8739399,13.719616,837314.024321116,1079339.83341199,122.803001403809,142,2.08920898144019,-0.106812779993978 +-139.25201,58.8666568,13.719616,841017.925018609,1079339.80037477,119.515121459961,142,2.07742285717664,-0.149623347413972 +-139.18919,58.8593432,13.719616,844721.646255147,1079339.73963211,120.699996948242,142,2.08170725911672,-0.134061176677526 +-139.12639,58.851999,13.719616,848425.75714467,1079339.76663408,115.665573120117,142,2.06320411410455,-0.201269880685125 +-139.06362,58.8446242,13.719616,852129.702635167,1079339.75335764,169.904083251953,142,2.23020381625858,0.405320703998909 +-139.00087,58.8372189,13.719616,855834.046873804,1079339.8381939,205.997451782227,142,2.31386184811788,0.709190554091457 +-138.93816,58.829783,13.719616,859537.676424986,1079339.75170425,210.427200317383,240,2.32310187704172,0.742752976509671 +-138.87547,58.8223166,13.719616,863241.716257436,1079339.76172746,217.600006103516,240,2.33765890320777,0.795628250533715 +-138.81281,58.8148197,13.719616,866945.611264245,1079339.73805334,165.682266235352,143,2.21927602629327,0.365627851743109 +-138.75017,58.8072923,13.719616,870649.92804077,1079339.81045365,121.91234588623,143,2.08604768821696,-0.11829549930366 +-138.68757,58.7997344,13.719616,874353.550613839,1079339.71597014,114.32933807373,143,2.05815768908827,-0.219599936737339 +-138.62499,58.7921461,13.719616,878057.603856117,1079339.726937,120.57829284668,143,2.08126913081051,-0.135652583739943 +-138.56244,58.7845274,13.719616,881761.532605676,1079339.71095612,119.402496337891,143,2.07701340664626,-0.151110588609117 +-138.49991,58.7768783,13.719616,885465.903402822,1079339.80007306,117.502288818359,143,2.07004632628011,-0.176417013101685 +-138.43742,58.7691988,13.719616,889169.600219275,1079339.72691037,107.288131713867,143,2.03055168267187,-0.319872831580408 +-138.37495,58.761489,13.719616,892873.747831665,1079339.76829668,84.2729644775391,40,1.92568827140542,-0.700766672297609 +-138.31251,58.7537488,13.719616,896577.793638759,1079339.77877828,84.1958999633789,40,1.92529094343986,-0.702209880877238 +-138.2501,58.7459783,13.719616,900281.740676169,1079339.76798358,76.5970993041992,40,1.88421232341808,-0.851419153801828 +-138.18772,58.7381774,13.719616,903985.597204903,1079339.72381958,82.7706909179688,40,1.91787658043274,-0.729140963589002 +-138.12536,58.7303463,13.719616,907689.924435606,1079339.80347108,95.6728439331055,40,1.98078868382044,-0.500626247182801 +-138.06304,58.722485,13.719616,911393.606241888,1079339.73292644,94.17138671875,40,1.97391896566094,-0.525579024350886 +-138.00074,58.7145934,13.719616,915097.772574503,1079339.77404203,87.2295303344727,40,1.94066353413241,-0.646372243707649 +-137.93847,58.7066715,13.719616,918801.868179349,1079339.78895789,73.8865737915039,40,1.8685655282729,-0.908252779809089 +-137.87623,58.6987195,13.719616,922505.893276165,1079339.79820185,57.8272438049316,40,1.76213249320564,-1.29484794218606 +-137.81402,58.6907373,13.719616,926209.856088749,1079339.78975372,40.3584213256836,40,1.6059341698802,-1.86220483594418 +-137.75184,58.6827249,12.31492772,929913.762167954,1079339.76245946,14.4436311721802,40,1.15967638989519,-3.48314046750135 +-153.07265,59.6689684,13.43091659,52065.9157272347,1075635.78037029,22.1935138702393,32,1.34622606895754,-2.80553878656735 +-153.00669,59.6684894,13.719616,55769.7633793245,1075635.77438119,31.3716697692871,32,1.49653763480512,-2.25956427621668 +-152.94073,59.6679775,13.719616,59473.721081374,1075635.76940631,38.4694900512695,32,1.58511642936927,-1.93782081145461 +-152.87477,59.6674328,13.719616,63177.795948962,1075635.77691074,37.5099220275879,32,1.5741461613775,-1.97766795602692 +-152.80881,59.6668551,13.719616,66881.9956543987,1075635.77483552,34.9402770996094,32,1.54332634490433,-2.08961432630891 +-152.74286,59.6662446,13.719616,70585.7656997073,1075635.77523412,35.1948356628418,32,1.54647894166918,-2.07816319501825 +-152.67691,59.6656012,13.719616,74289.6749895798,1075635.77677811,39.9402198791504,32,1.60141045142199,-1.87863627258221 +-152.61096,59.6649249,13.719616,77993.7308267219,1075635.77982487,56.8822250366211,32,1.75497657615748,-1.32084027540703 +-152.54501,59.6642156,13.719616,81697.9407581527,1075635.77357045,67.6840972900391,32,1.8304866410563,-1.04656616697627 +-152.47907,59.6634736,13.719616,85401.7499384138,1075635.77908794,79.5749588012695,32,1.9007764224437,-0.791253618276185 +-152.41313,59.6626986,13.719616,89105.7278149328,1075635.77499476,68.0830612182617,32,1.83303907469566,-1.03729499946102 +-152.34719,59.6618907,13.719616,92809.8814425893,1075635.77290087,57.828239440918,32,1.76213997057208,-1.29482078225688 +-152.28126,59.66105,13.719616,96513.6564191884,1075635.76990061,54.0586166381836,32,1.73286492789452,-1.40115609319088 +-152.21533,59.6601764,13.719616,100217.621722025,1075635.76869898,42.7435760498047,32,1.63087085366635,-1.77162768279473 +-152.1494,59.65927,13.719616,103921.784336908,1075635.78095892,35.2961196899414,32,1.54772696346502,-2.07363002363489 +-152.08348,59.6583306,13.719616,107625.590760455,1075635.76862152,34.4031143188477,32,1.53659775856775,-2.11405447241309 +-152.01756,59.6573584,13.719616,111329.609065886,1075635.76965424,26.1747798919678,32,1.41788303831246,-2.54526022093498 +-151.95164,59.6563533,13.719616,115033.846859357,1075635.77341881,31.0980587005615,32,1.49273327899634,-2.27338278238542 +-151.88573,59.6553154,13.719616,118737.749666635,1075635.77377039,28.5842514038086,32,1.45612682291194,-2.40634787940676 +-151.81982,59.6542446,13.719616,122441.88652594,1075635.77687149,30.6838283538818,32,1.48690954462635,-2.2945362478765 +-151.75392,59.653141,13.719616,126145.702938772,1075635.77549743,29.7363834381104,32,1.47328814816777,-2.3440130477477 +-151.3586,59.6458294,13.719616,148369.58205065,1075635.77142563,19.6554222106934,32,1.29348237717188,-2.99711892968132 +-151.29273,59.6444958,13.719616,152073.606077016,1075635.76416375,32.2435188293457,32,1.50844243154421,-2.21632265649302 +-151.22686,59.6431295,12.98525093,155777.928714718,1075635.78353252,62.3457832336426,32,1.79480708523573,-1.17616449767568 +-150.30539,59.6205562,9.813331523,207634.048937826,1075635.79132692,241.640167236328,33,2.38316912762765,0.960934375538024 +-150.04236,59.6129268,11.69577716,222450.009023679,1075635.78334391,36.3055381774902,33,1.55997287893324,-2.02914936332206 +-149.97663,59.6109377,13.719616,226153.526557864,1075635.76380812,81.9679946899414,133,1.91364431039776,-0.744513776366172 +-149.91089,59.6089158,13.719616,229858.049117847,1075635.79726282,212.728408813477,133,2.32782549162849,0.759910492942642 +-149.84517,59.6068611,13.719616,233561.899681486,1075635.78098943,172.089950561523,133,2.23575550982142,0.425486039630227 +-149.77946,59.6047738,13.09665841,237265.645451849,1075635.77082076,72.2094116210938,33,1.85859380627771,-0.944472920308425 +-149.71375,59.6026537,13.719616,240969.856426421,1075635.7801977,177.589904785156,33,2.24941827438902,0.475113100281034 +-149.64805,59.6005009,12.8298668,244673.977668433,1075635.78460503,42.4228057861328,33,1.62759938877125,-1.78351057706276 +-149.58236,59.5983155,13.30506874,248378.015606732,1075635.79471155,33.5160903930664,33,1.52525335304464,-2.15526059128875 +-149.51668,59.5960973,13.719616,252081.978886811,1075635.78773124,136.092346191406,133,2.1338337012481,0.0552769395115018 +-149.45101,59.5938465,13.719616,255785.873178896,1075635.78552491,268.494476318359,133,2.42893535547642,1.12717037806671 +-149.38535,59.5915629,13.719616,259489.707168226,1075635.76534506,218.998962402344,133,2.34044205719626,0.805737460211147 +-149.31969,59.5892467,13.719616,263194.04788834,1075635.78871597,239.76789855957,133,2.37979103692931,0.948664185918544 +-149.25405,59.5868979,13.719616,266897.779643468,1075635.77653117,222.589965820312,133,2.34750558278804,0.831394201291411 +-149.18841,59.5845164,13.719616,270602.033192544,1075635.79707337,200.778625488281,133,2.30271747676685,0.668711016424243 +-149.12279,59.5821022,13.719616,274305.692868244,1075635.76904286,192.220703125,133,2.28380016152569,0.599997927929035 +-149.05717,59.5796554,13.719616,278009.887816951,1075635.78529462,187.882186889648,133,2.273885606592,0.563985434514154 +-148.99156,59.5771759,13.719616,281714.064587912,1075635.79360046,181.42253112793,133,2.2586912217367,0.50879509181048 +-148.92597,59.5746638,13.719616,285417.668064989,1075635.76182074,183.348480224609,133,2.26327731444496,0.525453089528072 +-148.86038,59.5721191,13.719616,289121.828185733,1075635.77505628,178.543701171875,133,2.25174453336078,0.483562736846869 +-148.7948,59.5695418,13.719616,292825.99064954,1075635.79060856,106.52352142334,33,2.02744551478386,-0.33115531993825 +-148.72924,59.5669319,13.719616,296529.601153297,1075635.76356565,99.0740737915039,33,1.9959600209596,-0.44551962036261 +-148.66368,59.5642893,13.719616,300233.790524546,1075635.77128166,91.9280319213867,33,1.9634479624464,-0.563612696747941 +-148.59813,59.5616142,13.719616,303938.002670998,1075635.79172995,92.3605880737305,33,1.96548668947211,-0.556207458279951 +-148.5326,59.5589065,13.719616,307641.684168344,1075635.76723126,98.5732650756836,133,1.9937591420761,-0.453513840660881 +-148.46707,59.5561662,13.719616,311345.964938776,1075635.78968449,121.913238525391,133,2.0860508680987,-0.118283949065559 +-148.40156,59.5533933,13.719616,315049.729254268,1075635.76571039,163.997741699219,133,2.21483786771648,0.349507193015611 +-148.33606,59.5505879,13.719616,318753.544667252,1075635.75261783,194.770965576172,133,2.28952421727641,0.620789332223812 +-148.27056,59.5477499,13.719616,322457.980610467,1075635.78767977,214.711532592773,133,2.33185537190198,0.774548168338303 +-148.20508,59.5448794,13.719616,326161.920373224,1075635.78536216,205.919067382812,133,2.31369656262453,0.708590190002449 +-148.13961,59.5419764,13.719616,329865.932419243,1075635.79355523,215.374160766602,133,2.33319359817451,0.779408988127955 +-148.07415,59.5390408,13.719616,333570.024793966,1075635.8010322,208.999252319336,133,2.32014473245475,0.732011783316704 +-148.00871,59.5360726,13.719616,337273.643164606,1075635.75693806,182.889358520508,133,2.2621884366395,0.521497974541941 +-147.94327,59.533072,13.719616,340977.915394426,1075635.78450537,124.961494445801,133,2.09677621040073,-0.0793264445070936 +-147.87785,59.5300389,13.719616,344681.726696469,1075635.77042999,113.98217010498,133,2.05683692124324,-0.224397342535192 +-147.81244,59.5269733,13.719616,348385.645520093,1075635.76547746,111.895545959473,133,2.04881279963182,-0.253543242540185 +-147.74704,59.5238752,13.719616,352089.67889981,1075635.76964476,111.331596374512,133,2.04661843642559,-0.261513796038828 +-147.68165,59.5207446,13.719616,355793.83386713,1075635.78294616,110.871063232422,133,2.04481821235014,-0.268052723715976 +-147.61628,59.5175815,13.719616,359497.556038649,1075635.75128095,113.103515625,133,2.05347610441978,-0.236604788510599 +-147.55091,59.514386,13.719616,363201.97417946,1075635.79353349,106.409469604492,133,2.02698027846633,-0.332845191035188 +-147.48556,59.511158,13.719616,366905.973550355,1075635.78981638,123.839294433594,133,2.09285846898102,-0.0935567995782256 +-147.42023,59.5078976,13.719616,370609.56006455,1075635.74966627,130.606384277344,133,2.11596440656121,-0.00962943919577439 +-147.3549,59.5046048,13.719616,374313.863529096,1075635.7842332,148.563888549805,133,2.17191325821706,0.193592759410401 +-147.28959,59.5012795,13.719616,378017.769228217,1075635.77033802,219.635925292969,230,2.34170337803864,0.810318937527471 +-147.22429,59.4979219,13.719616,381721.843305849,1075635.78616749,213.309875488281,230,2.32901096220417,0.764216460440501 +-147.15901,59.4945318,13.719616,385425.533590535,1075635.75158541,214.419815063477,230,2.33126491709855,0.772403467959664 +-147.09373,59.4911093,13.719616,389129.968748591,1075635.79339655,219.053588867188,230,2.34055037284151,0.806130893551032 +-147.02847,59.4876545,13.719616,392834.031751761,1075635.80627262,215.433227539062,230,2.3333126879311,0.779841556115476 +-146.96323,59.4841672,13.719616,396537.731896227,1075635.7664985,211.272491455078,230,2.32484295381051,0.74907706428671 +-146.898,59.4806476,13.719616,400241.63520021,1075635.7551233,178.828063964844,140,2.25243567479923,0.486073159822724 +-146.83278,59.4770957,13.719616,403945.748588096,1075635.7723766,106.368606567383,41,2.02681347000497,-0.33345108697872 +-146.76758,59.4735114,13.719616,407649.518784298,1075635.74600688,89.9495544433594,41,1.95399901645011,-0.597933965604168 +-146.70239,59.4698948,13.719616,411353.512924821,1075635.74766245,84.062385559082,41,1.92460171044273,-0.704713371849478 +-146.63721,59.4662458,13.719616,415057.739160919,1075635.76651081,80.015754699707,41,1.90317550581078,-0.782539462720383 +-146.57205,59.4625646,13.719616,418761.640528056,1075635.76201975,56.6816520690918,41,1.75344249990348,-1.32641247823054 +-146.5069,59.458851,13.719616,422465.787830407,1075635.77421942,60.3893814086914,41,1.78096058098822,-1.22645895328844 +-146.44177,59.4551052,13.719616,426169.624052802,1075635.76149083,47.1246109008789,41,1.67324777734013,-1.61770260043329 +-146.37665,59.451327,13.71953517,429873.720035916,1075635.76501816,20.1373958587646,41,1.30400330746423,-2.95890390788701 +-146.24646,59.443674,13.719616,437281.588358716,1075635.75727124,28.7750129699707,41,1.45901552805458,-2.39585527781016 +-146.18138,59.439799,13.719616,440985.938453775,1075635.78873158,46.4313735961914,41,1.66681153174764,-1.64108088151263 +-146.11632,59.4358919,13.719616,444690.010532667,1075635.80324224,79.3920669555664,41,1.89977710885598,-0.794883410459295 +-146.05128,59.4319525,13.719616,448393.814082179,1075635.77735058,120.604804992676,140,2.08136461079115,-0.135305773197566 +-145.98625,59.4279809,13.719616,452097.916046362,1075635.78900665,351.872192382812,341,2.54638494693783,1.55378081770546 +-145.92124,59.4239771,13.719616,455801.761855088,1075635.77003725,549.24853515625,341,2.73976890733236,2.25620655913607 +-145.85624,59.4199411,13.719616,459505.919758236,1075635.78843712,680.447143554688,440,2.83279439529383,2.59410168352986 +-141.60663,59.0830258,13.48028318,703969.615661406,1075635.74200281,629.254333496094,440,2.7988262150936,2.47071955755873 +-141.54293,59.076863,13.719616,707673.960694112,1075635.81225674,473.235565185547,341,2.67507737581941,2.0212284518796 +-141.47926,59.0706689,13.719616,711377.924287712,1075635.80291677,372.616607666016,341,2.57126220766428,1.64414212934108 +-141.41562,59.0644436,13.719616,715081.510566404,1075635.72311428,311.793029785156,341,2.49386640219445,1.36301847291245 +-141.35199,59.0581871,13.719616,718785.848546978,1075635.78747524,277.391052246094,341,2.44309244800323,1.17859297896059 +-141.28839,59.0518994,13.719616,722489.821593254,1075635.77993949,246.607650756836,341,2.39200654602263,0.993034401598899 +-141.22481,59.0455806,13.719616,726193.995162068,1075635.81901703,240.648834228516,341,2.38138376217233,0.954449418610232 +-141.16126,59.0392306,13.719616,729897.816134547,1075635.78370077,229.480895996094,240,2.36074653689369,0.879489125947676 +-141.09773,59.0328494,13.719616,733601.852093878,1075635.78267151,202.265960693359,240,2.30592280157015,0.680353671000601 +-141.03423,59.0264372,13.719616,737305.543456577,1075635.72674537,196.149505615234,142,2.29258721784997,0.631915024574391 +-140.97074,59.0199939,13.719616,741010.02132306,1075635.82634886,191.219589233398,142,2.28153238093268,0.591760701526189 +-140.90729,59.0135194,13.719616,744713.609770692,1075635.73570772,182,142,2.26007138798507,0.513808249563239 +-140.84385,59.0070139,13.719616,748417.99478418,1075635.81142678,181,142,2.25767857486918,0.505116869349467 +-140.78044,59.0004774,13.719616,752122.059620675,1075635.82862175,179,142,2.25285303097989,0.487589116596209 +-140.71706,58.9939098,13.719616,755825.812576587,1075635.77462481,180,142,2.25527250510331,0.496377337199112 +-140.6537,58.9873113,13.719616,759529.816702058,1075635.78402003,183,142,2.26245108973043,0.522452005536869 +-140.59037,58.9806817,13.719616,763233.521101898,1075635.7199609,178,142,2.25042000230889,0.478751662007618 +-140.52705,58.9740212,13.719616,766938.050185186,1075635.83364932,176,142,2.24551266781415,0.460926822429992 +-140.46377,58.9673297,13.719616,770641.728000712,1075635.76769759,175,142,2.24303804868629,0.451938299431001 +-140.40051,58.9606072,13.719616,774345.683419617,1075635.75198733,170,142,2.23044892137827,0.406210995753595 +-140.33727,58.9538538,13.719616,778049.920200002,1075635.79750523,170,142,2.23044892137827,0.406210995753595 +-140.27406,58.9470696,13.719616,781753.880640747,1075635.7975284,169,142,2.22788670461367,0.396904293135091 +-140.21088,58.9402544,13.719616,785457.575318503,1075635.7285645,166,142,2.22010808804005,0.368650137501496 +-140.14772,58.9334084,13.719616,789161.567040167,1075635.72972716,162,142,2.20951501454263,0.330173070994654 +-140.08458,58.9265315,13.719616,792865.86408738,1075635.79016714,160,142,2.20411998265592,0.310576775286727 +-140.02147,58.9196238,13.719616,796569.908694596,1075635.80097565,159,142,2.20139712432045,0.300686576631144 +-139.95839,58.9126853,13.719616,800273.706806814,1075635.760591,155,142,2.19033169817029,0.260493790466696 +-139.89533,58.905716,13.719616,803977.825775164,1075635.78852565,155,142,2.19033169817029,0.260493790466696 +-139.8323,58.8987159,13.719616,807681.710121198,1075635.76329926,149,142,2.17318626841227,0.198216695792707 +-139.76929,58.891685,13.719616,811385.927184451,1075635.80556643,150.224838256836,142,2.17674174509199,0.211131201927514 +-139.70631,58.8846234,13.719616,815089.919087497,1075635.8036781,145.664489746094,142,2.16335369187325,0.162501971306226 +-139.64336,58.8775311,13.719616,818793.691715266,1075635.75613213,142.436645507812,142,2.15362173715469,0.127152733991988 +-139.58043,58.8704081,13.719616,822497.812358747,1075635.78528905,139.112915039062,142,2.14336745112668,0.0899062402736313 +-139.51753,58.8632543,13.719616,826201.727897645,1075635.75602566,139.717208862305,142,2.1452499011296,0.0967438359889542 +-139.45465,58.85607,13.719616,829905.998356156,1075635.824584,133.358032226562,142,2.12501917860571,0.0232600773590928 +-139.39181,58.848855,13.719616,833609.511588024,1075635.71831082,130.044250488281,142,2.11409115594434,-0.0164336201152046 +-139.32898,58.8416093,13.719616,837313.957684471,1075635.81233764,128.455307006836,142,2.10875205142972,-0.035826771644483 +-139.26619,58.834333,13.719616,841017.655799839,1075635.73957637,130.244537353516,142,2.11475951740745,-0.0140059405118324 +-139.20342,58.8270262,13.719616,844721.732100775,1075635.76222929,124.039512634277,142,2.09356005117493,-0.091008452798439 +-139.14068,58.8196888,13.719616,848425.633431506,1075635.74190469,158.178329467773,142,2.19914698461539,0.292513426968541 +-139.07796,58.8123208,13.719616,852129.927004775,1075635.80552182,196.873397827148,142,2.29418703682175,0.63772602371369 +-139.01527,58.8049223,13.719616,855834.054702821,1075635.83539966,215.426712036133,240,2.33329955305032,0.779793846479418 +-138.95261,58.7974933,13.719616,859538.022283689,1075635.8301644,218.302307128906,240,2.33905832557656,0.800711352012063 +-138.88998,58.7900338,13.719616,863241.835499423,1075635.78845496,221.000961303711,143,2.34439416277103,0.820092635701949 +-138.82737,58.7825438,13.719616,866946.061507944,1075635.83946534,151.208023071289,143,2.17957483536589,0.221421794446808 +-138.7648,58.7750233,13.719616,870649.583225462,1075635.72133268,112.917701721191,143,2.05276203011992,-0.239198510184795 +-138.70225,58.7674725,13.719616,874353.52410571,1075635.71614064,106.05517578125,143,2.0255318681226,-0.338106230821083 +-138.63972,58.7598912,13.719616,878057.894939584,1075635.80247776,104.836936950684,143,2.02051432355986,-0.356331384822753 +-138.57723,58.7522795,13.719616,881761.57605265,1075635.72604969,127.574348449707,143,2.10576335897237,-0.0466825557073196 +-138.51476,58.7446374,13.719616,885465.695953695,1075635.75055242,127.939476013184,143,2.10700456769584,-0.0421741313474362 +-138.45232,58.736965,13.719616,889169.696316862,1075635.75336203,122.004524230957,143,2.08637593569203,-0.117103210783049 +-138.38991,58.7292622,13.719616,892873.585387402,1075635.72233315,115.009735107422,143,2.06073460317528,-0.210239849248837 +-138.32752,58.7215292,13.719616,896577.925017315,1075635.81294879,96.5154190063477,40,1.98459670043651,-0.486794443917066 +-138.26517,58.7137658,13.719616,900281.603229109,1075635.7327701,89.6304397583008,40,1.95245552722896,-0.603540359011091 +-138.20284,58.7059721,13.719616,903985.745867274,1075635.76199442,84.0600204467773,40,1.92458949130731,-0.704757755237012 +-138.14054,58.6981482,13.719616,907689.79449371,1075635.77525066,88.3758850097656,40,1.94633377591877,-0.62577630709148 +-138.07827,58.6902941,13.719616,911393.754689342,1075635.77131691,100.208099365234,40,2.00090282499901,-0.427565945274744 +-138.01603,58.6824097,13.719616,915097.634693106,1075635.73812873,95.4681930541992,40,1.97985870266319,-0.504004204188989 +-137.95381,58.6744951,13.719616,918801.998841626,1075635.82369886,87.1065979003906,40,1.94005105194461,-0.648596953833589 +-137.89163,58.6665504,13.719616,922505.727189028,1075635.76154739,71.826057434082,40,1.8562820284601,-0.952869957189048 +-137.82947,58.6585755,13.719616,926209.950779417,1075635.81690526,54.1421356201172,40,1.73353538238646,-1.39872081110937 +-137.76735,58.6505704,13.719616,929913.552338926,1075635.71023613,34.261589050293,40,1.5348075016467,-2.12055719654054 +-137.70525,58.6425353,13.28804516,933617.654805297,1075635.74156386,16.9373054504395,40,1.22884431974404,-3.23190280379762 +-137.58114,58.6263747,9.375164891,941025.711063736,1075635.75186344,133.419464111328,40,2.1252191919457,0.0239865828994226 +-153.46899,59.6380284,10.755553,29841.785234188,1071931.77616444,21.8862705230713,32,1.34017176297303,-2.82752975397407 +-153.13947,59.6362933,13.68515821,48361.8791133466,1071931.78118512,25.4669551849365,32,1.40597702405954,-2.58850626301638 +-153.07357,59.6358476,13.719616,52065.9297732344,1071931.77426737,31.1000003814697,32,1.49276039435385,-2.27328429166744 +-153.00768,59.6353691,13.719616,55769.520899196,1071931.76788046,35.6978073120117,32,1.55264154099905,-2.05577887527121 +-152.94178,59.6348578,13.719616,59473.783698983,1071931.77852696,38.9921531677246,32,1.59097721782564,-1.91653275494547 +-152.87589,59.6343136,13.719616,63177.601690602,1071931.77795651,36.2214431762695,32,1.55896574998146,-2.03280754313812 +-152.81,59.6337365,13.719616,66881.5441444295,1071931.77486873,37.4005470275879,32,1.57287795432148,-1.98227444603671 +-152.74411,59.6331265,13.719616,70585.6183606544,1071931.76958377,39.0777359008789,32,1.5919293934746,-1.91307418121049 +-152.67822,59.6324837,13.719616,74289.8314163214,1071931.77362002,51.8643989562988,32,1.71486934932932,-1.46652117098917 +-152.61234,59.6318081,13.719616,77993.6286074874,1071931.77558934,53.8803939819336,32,1.73143076269226,-1.40636539055696 +-152.54646,59.6310996,13.719616,81697.5794135324,1071931.77531499,76.7366333007812,32,1.88500274129223,-0.848548130475178 +-152.48058,59.6303582,13.719616,85401.6911320627,1071931.77318997,72.469482421875,32,1.86015515959168,-0.938801639417469 +-152.4147,59.629584,13.719616,89105.9707930517,1071931.78080448,57.1362228393555,32,1.75691152666195,-1.31381198288493 +-152.34883,59.6287769,13.719616,92809.8639677141,1071931.77343341,57.9170112609863,32,1.76280614251313,-1.29240105562259 +-152.28296,59.627937,13.719616,96513.9396319177,1071931.77556233,54.2763786315918,32,1.73461086343901,-1.39481435695366 +-152.2171,59.6270643,13.719616,100217.643077276,1071931.77256564,48.6130294799805,32,1.68675268639941,-1.56864891604518 +-152.15124,59.6261587,13.719616,103921.543845042,1071931.76772366,36.5549659729004,32,1.56294638397865,-2.01834874427428 +-152.08538,59.6252203,13.719616,107625.648905632,1071931.77271598,35.8910980224609,32,1.55498674498137,-2.04726042501957 +-152.01952,59.624249,13.719616,111329.965851029,1071931.77688479,33.8511581420898,32,1.52957353169516,-2.13956846932831 +-151.95367,59.623245,13.719616,115033.939313469,1071931.7858007,29.1338863372803,32,1.46439842154002,-2.37630307224026 +-151.88783,59.622208,13.719616,118737.577583078,1071931.76481566,27.1477355957031,32,1.4337336107461,-2.48768641765219 +-151.82198,59.6211383,13.719616,122442.010821224,1071931.78323448,29.1740303039551,32,1.46499642973402,-2.37413093579113 +-151.75615,59.6200357,13.719616,126145.561095813,1071931.76398555,33.4053382873535,32,1.52381587410161,-2.16048192510719 +-151.69031,59.6189004,13.719616,129849.920824799,1071931.78534147,31.1358528137207,32,1.49326076558402,-2.27146680053931 +-151.62448,59.6177322,13.719616,133553.974087839,1071931.78703205,22.6521987915039,32,1.35511036425921,-2.77326849020136 +-151.36122,59.6127313,13.719616,148369.512031933,1071931.76681784,61.4974250793457,32,1.78885693208042,-1.19777715227858 +-151.29541,59.6113991,13.51868537,152073.825740381,1071931.78194274,79.2612075805664,32,1.89906068472264,-0.797485667399396 +-151.22961,59.610034,12.09641038,155777.876560292,1071931.77486037,39.1065673828125,32,1.5922496970023,-1.91191074737414 +-150.04628,59.5798609,13.719616,222449.928119118,1071931.78133322,77.4833450317383,133,1.88920836136906,-0.833272117952657 +-149.98061,59.5778737,13.719616,226153.713725396,1071931.77330444,185.027084350586,133,2.2672353052844,0.539829641979975 +-149.91494,59.5758537,13.719616,229857.942299319,1071931.78057212,209.990646362305,133,2.32219995033531,0.739476921276486 +-149.84928,59.5738011,13.719616,233562.057684365,1071931.79140045,182.189208984375,133,2.26052265025868,0.515447362944039 +-149.78363,59.5717158,13.719616,237266.067731715,1071931.79408363,152.682022094727,33,2.18378790303739,0.236724858758898 +-149.71799,59.5695978,13.719616,240969.979614158,1071931.78809509,127.408058166504,33,2.10519689665376,-0.0487401085329431 +-149.65236,59.5674471,13.71230582,244673.8005024,1071931.77292602,81.3004684448242,33,1.91009304796081,-0.757412975168386 +-149.58674,59.5652638,13.719616,248377.536822511,1071931.75924253,106.035507202148,133,2.02545131809301,-0.338398811519826 +-149.52112,59.5630478,13.719616,252081.758431062,1071931.77337043,109.044120788574,133,2.03760225517001,-0.294263139833447 +-149.45551,59.5607992,13.719616,255785.909758139,1071931.78916747,162.614135742188,133,2.21115829530475,0.33614193576168 +-149.38991,59.5585179,13.719616,259489.998708366,1071931.7950385,167.762283325195,133,2.22469432845386,0.385308671727761 +-149.32432,59.5562039,13.719616,263194.032441597,1071931.7905633,242.489807128906,133,2.38469348809001,0.966471287833092 +-149.25874,59.5538573,13.719616,266898.017317797,1071931.78649266,227.755294799805,133,2.35746848213508,0.867582295414457 +-149.19317,59.5514782,13.719616,270601.959650581,1071931.79359184,211.243698120117,133,2.324783761823,0.748862062092992 +-149.12761,59.5490663,13.719616,274305.868985782,1071931.77803359,196.109558105469,133,2.29249876108901,0.631593724370511 +-149.06206,59.5466219,13.719616,278009.750015083,1071931.77292344,189.576934814453,133,2.27778549707296,0.578150949880556 +-148.99652,59.5441449,13.719616,281713.610662316,1071931.76677435,185.705261230469,133,2.26882420794545,0.545600989962871 +-148.93098,59.5416352,13.719616,285418.020862547,1071931.79109767,181.940872192383,133,2.25993027231073,0.513295677155584 +-148.86546,59.539093,13.719616,289121.862092558,1071931.78249608,176.52522277832,133,2.24680676825538,0.465627364605591 +-148.79995,59.5365182,13.719616,292825.704271492,1071931.77195745,95.782958984375,33,1.98128824939834,-0.498811682413635 +-148.73445,59.5339108,13.719616,296529.554504705,1071931.75921745,81.54248046875,33,1.91138391827024,-0.752724165753453 +-148.66895,59.5312708,13.719616,300233.981864649,1071931.7892377,88.1131210327148,33,1.9450405845506,-0.630473547254224 +-148.60347,59.5285983,13.719616,303937.868604691,1071931.78307461,91.9090957641602,33,1.96335849337425,-0.563937673955031 +-148.538,59.5258932,13.719616,307641.784677753,1071931.77402044,95.8571929931641,33,1.98162470730308,-0.497589571268974 +-148.47254,59.5231556,13.719616,311345.736249267,1071931.77302378,103.953750610352,133,2.01684016312391,-0.369676984235947 +-148.40709,59.5203854,13.719616,315049.731319216,1071931.76876286,120.407875061035,133,2.0806548921021,-0.137883674050094 +-148.34165,59.5175827,13.719616,318753.776025725,1071931.77221927,181.648696899414,133,2.25923228669406,0.510760394170924 +-148.27622,59.5147475,13.719616,322457.877422804,1071931.78324808,204.395935058594,133,2.3104722544804,0.696878582513799 +-148.2108,59.5118798,13.719616,326162.042561729,1071931.80172169,209.537368774414,133,2.32126148603882,0.736068151087244 +-148.1454,59.5089795,13.719616,329865.717505836,1071931.76672132,213.546752929688,133,2.32949297217848,0.765967258246562 +-148.08,59.5060468,13.719616,333570.031282118,1071931.79921431,212.020690917969,133,2.32637824542413,0.754653681643213 +-148.01462,59.5030816,13.719616,337273.86796768,1071931.78808747,205.560394287109,133,2.31293944203781,0.705840111927732 +-147.94925,59.5000838,13.719616,340977.797589492,1071931.77181757,158.163284301758,133,2.19910567463718,0.292363377336665 +-147.88389,59.4970537,13.719616,344681.824132607,1071931.78376912,113.505867004395,133,2.0550183103554,-0.231003056363028 +-147.81854,59.493991,13.719616,348385.957683244,1071931.79051275,110.699508666992,133,2.04414569329347,-0.270495504885849 +-147.75321,59.4908959,13.719616,352089.64123543,1071931.76129239,115.176200866699,133,2.06136274905202,-0.207958244133823 +-147.68788,59.4877684,13.719616,355794.005723799,1071931.80159131,114.899673461914,133,2.06031879445077,-0.21175018521987 +-147.62257,59.4846084,13.719616,359497.935273583,1071931.79371294,113.716163635254,133,2.05582219976846,-0.228083100561926 +-147.55727,59.4814159,13.719616,363201.998876578,1071931.790719,114.767654418945,133,2.05981950577343,-0.213563744207132 +-147.49199,59.4781911,13.719616,366905.639394278,1071931.75967963,117.506187438965,133,2.07006073554265,-0.176364674547344 +-147.42671,59.4749339,13.719616,370609.988821225,1071931.7994785,121.937187194824,133,2.08613617264542,-0.117974098603512 +-147.36145,59.4716442,13.719616,374313.931314077,1071931.78802995,137.832397460938,133,2.13935131034958,0.0753184706504788 +-147.2962,59.4683222,13.719616,378018.033598585,1071931.8029442,207.994140625,230,2.31805110068357,0.72440711514176 +-147.23097,59.4649678,13.719616,381721.741783763,1071931.77574307,211.320205688477,230,2.32494102473555,0.749433285878672 +-147.16575,59.461581,13.719616,385425.624809745,1071931.76293398,210.685501098633,230,2.32363464946895,0.74468815803378 +-147.10054,59.4581618,13.719616,389129.689643788,1071931.76467817,214.411529541016,230,2.33124813494523,0.772342510388734 +-147.03534,59.4547103,13.719616,392833.942079414,1071931.7922738,212.922393798828,230,2.32822134012226,0.761348327658421 +-146.97016,59.4512264,13.719616,396537.82825631,1071931.77508422,205.454650878906,230,2.31271597683753,0.705028422536989 +-146.90499,59.4477103,13.719616,400241.914716888,1071931.79415087,191.216979980469,230,2.28152645480406,0.591739176135551 +-146.83984,59.4441617,13.719616,403945.649989641,1071931.75552144,159.931243896484,140,2.20393331506791,0.309898745326839 +-146.7747,59.4405809,13.719616,407649.599385242,1071931.75250066,111.092346191406,140,2.0456841388568,-0.264907431483765 +-146.70957,59.4369678,13.719616,411353.77101046,1071931.77423014,102.450569152832,41,2.01051437541899,-0.392654050739779 +-146.64446,59.4333224,13.719616,415057.609806722,1071931.75848766,100.902755737305,41,2.00390302733862,-0.416668354034306 +-146.57936,59.4296447,13.719616,418761.684651243,1071931.76694886,89.3923568725586,41,1.95130038781188,-0.607736155083518 +-146.51427,59.4259347,13.719616,422466.002448114,1071931.79992339,79.8152160644531,41,1.90208569364253,-0.786497971578841 +-146.4492,59.4221925,13.719616,426170.006859732,1071931.80467515,32.9597053527832,41,1.51798332061512,-2.18166742414662 +-146.25408,59.4107723,13.719616,437281.899522504,1071931.78945199,23.1299877166748,41,1.36417540213587,-2.74034168521391 +-146.18907,59.4069011,13.719616,440985.845607862,1071931.78041624,87.1924743652344,41,1.94047900233287,-0.647042515874222 +-146.12408,59.4029977,13.719616,444689.512637346,1071931.73889114,120.561866760254,140,2.08120996390346,-0.135867494834272 +-146.05909,59.3990622,13.719616,448394.030062699,1071931.80976319,159.547714233398,140,2.20289058663713,0.306111258041893 +-145.99413,59.3950944,13.719616,452097.72147423,1071931.76871382,477.732177734375,341,2.67918449424931,2.03614667830531 +-141.4914,59.0381225,11.80017473,711377.616027226,1071931.74342768,584.358337402344,440,2.76667924476866,2.3539525856797 +-141.42781,59.031903,13.71573053,715081.692716206,1071931.75144621,510.939880371094,440,2.70836980197597,2.1421560462847 +-141.36424,59.0256524,13.719616,718785.954622463,1071931.80368705,454.479919433594,440,2.65751469928111,1.95743579780553 +-141.3007,59.0193707,13.719616,722489.845930576,1071931.79119461,430.064147949219,341,2.63353323935296,1.87032829035635 +-141.23718,59.0130577,13.719616,726193.939029331,1071931.7995468,387.886688232422,341,2.58870487543299,1.70749887731009 +-141.17369,59.0067137,13.719616,729897.671718491,1071931.75162646,449.261810302734,341,2.65249950276908,1.93921917259423 +-141.11022,59.0003386,13.719616,733601.614230358,1071931.74512626,425.960357666016,241,2.62936918302759,1.85520324924261 +-141.04677,58.9939323,13.719616,737305.774864069,1071931.76897063,280.09814453125,241,2.44731023191351,1.19391317399808 +-140.98335,58.987495,13.719616,741009.59345435,1071931.73342151,192,142,2.28330122870355,0.598185661509398 +-140.91995,58.9810267,13.719616,744713.638061023,1071931.74885564,191,142,2.28103336724773,0.589948141389748 +-140.85657,58.9745273,13.719616,748417.916966758,1071931.80423938,186,142,2.26951294421792,0.548102676689368 +-140.79322,58.9679969,13.719616,752121.872104057,1071931.79722575,185,142,2.26717172840301,0.539598712600118 +-140.7299,58.9614354,13.719616,755825.511765423,1071931.7151399,182,142,2.26007138798507,0.513808249563239 +-140.66659,58.954843,13.719616,759529.961530941,1071931.80692754,182,142,2.26007138798507,0.513808249563239 +-140.60332,58.9482197,13.719616,763233.541522943,1071931.72946044,180,142,2.25527250510331,0.496377337199112 +-140.54006,58.9415653,13.719616,766937.948176257,1071931.80393246,179,142,2.25285303097989,0.487589116596209 +-140.47683,58.9348801,13.719616,770642.056852521,1071931.8327932,179,142,2.25285303097989,0.487589116596209 +-140.41363,58.9281639,13.719616,774345.878076865,1071931.79248888,178,142,2.25042000230889,0.478751662007618 +-140.35045,58.9214168,13.719616,778049.977577569,1071931.80948305,181,142,2.25767857486918,0.505116869349467 +-140.2873,58.9146389,13.719616,781753.79709638,1071931.77704604,186,142,2.26951294421792,0.548102676689368 +-140.22417,58.9078301,13.719616,785457.906871365,1071931.80088894,169,142,2.22788670461367,0.396904293135091 +-140.16107,58.9009904,13.719616,789161.750924669,1071931.76225277,167,142,2.22271647114758,0.378124529454699 +-140.09799,58.89412,13.719616,792865.892566146,1071931.80080474,164,142,2.2148438480477,0.349528915285568 +-140.03494,58.8872187,13.719616,796569.780410808,1071931.77481999,165,142,2.21748394421391,0.359118498119706 +-139.97191,58.8802866,13.719616,800273.980059207,1071931.81416932,161,142,2.20682587603185,0.320405352366949 +-139.90891,58.8733238,13.719616,803977.933125413,1071931.80883711,163,142,2.21218760440396,0.339880680204086 +-139.84594,58.8663302,13.719616,807681.647874643,1071931.74634935,167,142,2.22271647114758,0.378124529454699 +-139.78299,58.8593059,13.719616,811385.689827969,1071931.75827636,159.514511108398,142,2.20280019715899,0.305782937657561 +-139.72006,58.8522508,13.719616,815090.067259739,1071931.83384837,159.892791748047,142,2.20382888541846,0.309519427032843 +-139.65717,58.8451651,13.719616,818793.65735444,1071931.74848904,156.049407958984,142,2.19326212532026,0.271137938302575 +-139.5943,58.8380487,13.719616,822497.592303705,1071931.73580527,152.601470947266,142,2.18355871986527,0.23589240006238 +-139.53145,58.8309016,13.719616,826201.877979349,1071931.79598719,150.690338134766,142,2.17808540739576,0.216011766934197 +-139.46863,58.8237239,13.719616,829905.955851362,1071931.81518429,147.140701293945,142,2.16773282162197,0.178408220481631 +-139.40584,58.8165155,13.719616,833609.83418551,1071931.78102372,142.013244628906,142,2.15232885002399,0.122456598906535 +-139.34308,58.8092766,13.719616,837313.513942086,1071931.71387458,142.826248168945,142,2.15480802808016,0.131461681234418 +-139.28034,58.8020071,13.719616,841017.565334405,1071931.7280258,138.951278686523,142,2.14286254768731,0.0880722868680395 +-139.21762,58.794707,13.719616,844721.994173904,1071931.82372542,161.500549316406,142,2.20817400384779,0.325302137388441 +-139.15494,58.7873763,13.719616,848425.682326821,1071931.74572695,192.687362670898,142,2.28485323254717,0.603822982455435 +-139.09228,58.7800152,13.719616,852129.754555829,1071931.76937463,215.397583007812,240,2.33324082573885,0.779580532121714 +-139.02965,58.7726235,13.719616,855833.659619895,1071931.74428221,225.007797241211,240,2.35219756806762,0.848436831052772 +-138.96704,58.7652013,13.719616,859537.96276765,1071931.8093949,226.512954711914,240,2.35509304519658,0.858954030436598 +-138.90447,58.7577487,13.719616,863241.5432918,1071931.71593794,190.952331542969,143,2.28092496551145,0.589554395342657 +-138.84192,58.7502656,13.719616,866945.533374729,1071931.7110725,137.652420043945,143,2.13878385105439,0.0732572965213693 +-138.77939,58.7427521,13.719616,870649.936215904,1071931.80601353,120.710426330566,143,2.08174478378641,-0.133924876366626 +-138.7169,58.7352082,13.719616,874353.633578093,1071931.73778063,102.450736999512,143,2.01051508693116,-0.392651466324482 +-138.65443,58.7276339,13.719616,878057.755096559,1071931.76780642,105.382278442383,143,2.02276758410446,-0.348146899380193 +-138.59199,58.7200292,13.719616,881761.744491611,1071931.76367786,111.365142822266,143,2.04674927837065,-0.261038540748371 +-138.52958,58.7123942,13.719616,885465.604866941,1071931.7349696,129.255752563477,143,2.11144988059368,-0.0260274860838665 +-138.46719,58.7047288,13.719616,889169.906429734,1071931.8034024,131.920364379883,143,2.12031184221161,0.00616168796814774 +-138.40484,58.6970331,13.719616,892873.528311827,1071931.71135083,125.149360656738,143,2.09742863529494,-0.076956651070721 +-138.34251,58.6893071,13.719616,896577.600087469,1071931.72587945,119.483207702637,143,2.07730687336342,-0.150044633728674 +-138.28021,58.6815509,13.719616,900281.562794932,1071931.72270608,109.45287322998,143,2.03922716664902,-0.288360997545777 +-138.21793,58.6737644,13.719616,903985.986627188,1071931.82583408,97.9455490112305,40,1.99098470491694,-0.46359138832614 +-138.15569,58.6659476,13.719616,907689.753261575,1071931.76234755,90.6501998901367,40,1.9573687660828,-0.585694073115952 +-138.09347,58.6581007,13.719616,911393.986944855,1071931.82553699,95.4364776611328,40,1.97971440215681,-0.504528344815611 +-138.03129,58.6502235,13.719616,915097.574604295,1071931.71855462,102.9541015625,143,2.01264365304709,-0.384919906638173 +-137.96913,58.6423162,13.719616,918801.640433699,1071931.73693592,92.4175186157227,40,1.96575430365503,-0.555235407182905 +-137.907,58.6343787,13.719616,922505.630676307,1071931.73139481,85.7816467285156,40,1.9333943790241,-0.672775889884493 +-137.8449,58.6264111,13.719616,926209.548195306,1071931.71159731,70.8838348388672,40,1.85054720498943,-0.973700472916132 +-137.78282,58.6184134,13.719616,929913.960478915,1071931.81639035,51.5986289978027,40,1.71263816235203,-1.47462547893484 +-137.72078,58.6103856,13.719616,933617.74910027,1071931.76511858,35.8657302856445,40,1.55467967821611,-2.04837577915655 +-137.65876,58.6023277,11.43758485,937322.043504779,1071931.83723438,19.6199836730957,40,1.29269864164294,-2.9999656808228 +-153.53536,59.6051533,11.00453664,26137.6980745639,1068227.77796753,12.4071016311646,32,1.09367033970942,-3.72289328177847 +-153.46952,59.6049051,13.719616,29841.5864992639,1068227.77389722,12.914176940918,32,1.11106673250639,-3.65970461771502 +-153.40368,59.6046241,13.6384156,33545.533554651,1068227.77454241,14.0927619934082,32,1.1489961173779,-3.52193426573743 +-153.33784,59.6043102,13.7178517,37249.5466192675,1068227.76887713,17.053071975708,32,1.23180262508358,-3.22115739442001 +-153.272,59.6039636,13.719616,40953.6327479643,1068227.77943809,18.9096126556396,32,1.27668263285132,-3.058140396178 +-153.20616,59.603584,13.719616,44657.799574884,1068227.77287305,26.2197113037109,32,1.41862790551213,-2.5425546506595 +-153.14032,59.6031717,13.719616,48362.0539983582,1068227.78293606,27.3999996185303,32,1.43775055677403,-2.4730957231282 +-153.07449,59.6027265,13.719616,52065.8410350835,1068227.77965302,32.9000015258789,32,1.51719591809225,-2.18452749485674 +-153.00866,59.6022484,13.719616,55769.7305109064,1068227.76999512,37.9080352783203,32,1.57873127612004,-1.96101351055998 +-152.94283,59.6017376,13.719616,59473.7293678572,1068227.77658856,38.6487121582031,32,1.58713502705371,-1.93048868849955 +-152.877,59.6011939,13.719616,63177.8452151165,1068227.77735457,38.914493560791,32,1.59011138284633,-1.91967771472424 +-152.81118,59.6006174,13.719616,66881.5226221517,1068227.77370379,40.0628700256348,32,1.6027420580791,-1.8737994971252 +-152.74535,59.600008,13.719616,70585.8941181283,1068227.77435913,48.3870391845703,32,1.68472904833009,-1.57599934711679 +-152.67953,59.5993659,13.719616,74289.8414995044,1068227.78131838,54.0358123779297,32,1.73268168506454,-1.40182168345209 +-152.61371,59.5986909,13.719616,77993.9349891774,1068227.78264775,55.8879890441895,32,1.74731848315815,-1.34865665501798 +-152.5479,59.5979831,13.719616,81697.619109854,1068227.77759878,77.6528778076172,32,1.89015755527139,-0.829824374772485 +-152.48208,59.5972424,13.719616,85402.0264324445,1068227.77942972,68.6499862670898,32,1.83664045469546,-1.02421375936555 +-152.41627,59.596469,13.719616,89106.0386620736,1068227.78574716,54.1076240539551,32,1.73325846383627,-1.3997266583241 +-152.35047,59.5956627,13.719616,92809.6635800754,1068227.77294765,55.6246871948242,32,1.74526758174281,-1.35610611434403 +-152.28466,59.5948236,13.719616,96514.0332439798,1068227.78004847,49.7294654846191,32,1.69661379125861,-1.53283056855704 +-152.21886,59.5939517,13.719616,100218.029856577,1068227.77900568,42.9462203979492,32,1.63292494855043,-1.76416662387869 +-152.15307,59.593047,13.719616,103921.660674544,1068227.76862809,38.0552711486816,32,1.58041482069225,-1.95489839614225 +-152.08727,59.5921095,13.719616,107626.058008407,1068227.78015461,37.8919944763184,32,1.57854746532415,-1.96168116383547 +-152.02149,59.5911392,13.719616,111329.541530928,1068227.76548541,36.0231819152832,32,1.55658207126021,-2.04146574462334 +-151.9557,59.5901361,13.719616,115033.806078127,1068227.77377481,32.9965286254883,32,1.51846825266288,-2.17990601253575 +-151.88992,59.5891002,13.719616,118737.733848205,1068227.77149195,29.7765331268311,32,1.47387413157821,-2.34188458874467 +-151.82414,59.5880315,13.719616,122441.894620438,1068227.77597304,33.2060089111328,32,1.52121668011412,-2.16992293955354 +-151.75837,59.58693,13.719616,126145.733118326,1068227.76881387,51.4984283447266,32,1.71179397522317,-1.47769180754187 +-151.6926,59.5857958,13.719616,129849.818730591,1068227.77967746,38.193473815918,32,1.58198916061143,-1.94917994419443 +-151.62684,59.5846287,13.719616,133553.596944323,1068227.76672947,38.7062034606934,32,1.58778057516986,-1.92814387348393 +-151.56108,59.5834289,13.719616,137257.636746483,1068227.77195928,59.4285354614258,32,1.77399502777027,-1.25175983074287 +-151.49532,59.5821963,13.719616,140961.945771847,1068227.7848544,61.8608131408691,32,1.79141562436861,-1.18848325156439 +-151.42957,59.5809309,13.71956374,144665.968738168,1068227.78431219,96.4609146118164,32,1.984351375448,-0.48768553429806 +-151.36383,59.5796327,13.66701438,148369.712889338,1068227.76935818,97.0250244140625,32,1.98688376069205,-0.478487188276983 +-150.57533,59.5615003,8.78681268,192818.005786308,1068227.78838775,113.338417053223,33,2.05437714275182,-0.23333196010669 +-150.37835,59.5562308,12.59786456,203929.922301451,1068227.78186326,102.429481506348,33,2.01042497434253,-0.392978780967082 +-150.18143,59.550667,8.61783043,215042.050836562,1068227.78518043,67.4169921875,33,1.828769372547,-1.05280377635926 +-150.11581,59.5487471,13.40703329,218745.798649469,1068227.77718886,80.9519348144531,33,1.90822723319067,-0.764190146970076 +-150.05019,59.5467945,13.719616,222449.973745211,1068227.79151736,80.5622787475586,33,1.90613174197324,-0.771801569184533 +-149.98458,59.5448092,13.719616,226154.020773635,1068227.79518541,136.085922241211,133,2.13381320081551,0.0552024760889251 +-149.91898,59.5427912,13.719616,229857.946910014,1068227.78761073,207.952285766602,133,2.31796369839831,0.724089645094626 +-149.85339,59.5407405,13.719616,233561.759327645,1068227.76822877,188.73942565918,133,2.2758626291409,0.571166544710145 +-149.7878,59.5386573,13.719616,237266.026307693,1068227.79453816,179.868698120117,133,2.25495559126932,0.495226215697848 +-149.72223,59.5365413,13.719616,240969.632057832,1068227.76163397,109.395065307617,33,2.03899773188765,-0.289194370086248 +-149.65666,59.5343928,13.67752506,244673.706640698,1068227.77449192,80.2849197387695,33,1.90463397754159,-0.777241877104834 +-149.5911,59.5322116,13.69405457,248377.696111482,1068227.77457301,99.5271224975586,133,1.9979414480411,-0.438322511647025 +-149.52555,59.5299977,13.719616,252081.607633123,1068227.76140125,104.939659118652,133,2.02093964912162,-0.354786480982439 +-149.46,59.5277513,13.719616,255786.00936614,1068227.79534513,136.045059204102,133,2.1336827739779,0.0547287285871736 +-149.39447,59.5254722,13.719616,259489.784897955,1068227.77717649,129.396469116211,133,2.11192242575874,-0.024311067166526 +-149.32894,59.5231605,13.719616,263194.065653826,1068227.79521525,205.629043579102,133,2.31308445553393,0.706366842336603 +-149.26343,59.5208162,13.719616,266897.733700088,1068227.77034946,234.026336669922,133,2.36926473444776,0.910429650799703 +-149.19792,59.5184393,13.719616,270601.921210269,1068227.78200883,217.560684204102,133,2.33758041595302,0.795343162421948 +-149.13243,59.5160299,13.719616,274305.509427284,1068227.76003726,205.217544555664,133,2.31221448693684,0.703206868078247 +-149.06694,59.5135878,13.719616,278009.632146642,1068227.76382647,191.124374389648,133,2.2813160768399,0.590975023321876 +-149.00146,59.5111132,13.719616,281713.73230409,1068227.77459501,183.000778198242,133,2.26245293654182,0.522458713682958 +-148.93599,59.508606,13.719616,285417.817827797,1068227.78087139,186.377243041992,133,2.27039288320765,0.551298866259684 +-148.87053,59.5060662,13.719616,289121.895824666,1068227.78235328,172.006927490234,133,2.2355459382459,0.424724815850282 +-148.80508,59.5034939,13.719616,292825.972525355,1068227.78990324,98.9390106201172,33,1.99536756314993,-0.44767159623163 +-148.73964,59.500889,13.719616,296530.0558836,1068227.79210481,81.8876876831055,33,1.91321860782566,-0.746060049615643 +-148.67422,59.4982516,13.719616,300233.589575699,1068227.7546453,99.7445220947266,33,1.9988890538389,-0.434880536915793 +-148.6088,59.4955817,13.719616,303937.705720282,1068227.76714873,96.3288345336914,33,1.98375630586232,-0.489846996883011 +-148.54339,59.4928793,13.719616,307641.848851303,1068227.7847467,106.254447937012,133,2.02634711918416,-0.335145006269682 +-148.47799,59.4901443,13.719616,311346.026956123,1068227.79609601,113.300994873047,133,2.05423372333187,-0.233852900375948 +-148.41261,59.4873768,13.719616,315049.683656718,1068227.76471907,135.214767456055,133,2.13102412558818,0.0450717587819375 +-148.34723,59.4845768,13.719616,318753.951061194,1068227.78477131,174.961700439453,133,2.24294299092511,0.45159302251021 +-148.28187,59.4817444,13.719616,322457.710203924,1068227.77180808,204.006072998047,133,2.30964309600572,0.693866842268349 +-148.21652,59.4788794,13.719616,326161.532572368,1068227.75085673,210.675720214844,133,2.32361448727251,0.744614923181442 +-148.15117,59.475982,13.719616,329865.985804976,1068227.79375312,208.075241088867,133,2.31822040650577,0.725022082212712 +-148.08584,59.4730521,13.719616,333569.952850952,1068227.79047792,205.149963378906,133,2.31207144377751,0.702687294494959 +-148.02052,59.4700897,13.719616,337274.003277195,1068227.79006466,200.972290039062,133,2.30313618123775,0.670231870572698 +-147.95522,59.4670949,13.719616,340977.580576684,1068227.75224312,174.247924804688,133,2.2411676145965,0.445144348941844 +-147.88992,59.4640677,13.719616,344681.816805099,1068227.779095,134.966339111328,133,2.13022546804296,0.0421708066181151 +-147.82464,59.461008,13.719616,348385.594943974,1068227.75621198,114.838371276855,133,2.06008702438098,-0.212592040267116 +-147.75936,59.4579159,13.719616,352090.046026803,1068227.79907621,113.79273223877,133,2.05611452524542,-0.227021290991612 +-147.6941,59.4547914,13.719616,355794.051990979,1068227.80221577,114.33763885498,133,2.05818921951337,-0.219485409233712 +-147.62886,59.4516345,13.719616,359497.619825638,1068227.76397846,114.686614990234,133,2.05951273459624,-0.214678024683903 +-147.56362,59.4484451,13.719616,363201.882653586,1068227.78098022,116.769081115723,133,2.06732786265279,-0.186291248922893 +-147.4984,59.4452234,13.719616,366905.720250125,1068227.76671284,117.216133117676,133,2.06898739019561,-0.180263371211056 +-147.43319,59.4419693,13.719616,370609.703193618,1068227.76425088,116.971008300781,133,2.06807823358191,-0.183565687531159 +-147.36799,59.4386829,13.719616,374313.837346164,1068227.78480921,126.147163391113,133,2.10087748919812,-0.0644294292934577 +-147.30281,59.435364,13.719616,378017.569372644,1068227.749321,201.00846862793,230,2.30321435493742,0.670515819762893 +-147.23763,59.4320129,13.719616,381722.027921337,1068227.80456706,203.633865356445,230,2.30885000507137,0.690986109624127 +-147.17248,59.4286293,13.719616,385425.535754426,1068227.74487838,201.20783996582,230,2.30364489878726,0.672079677914994 +-147.10733,59.4252135,13.719616,389129.783975638,1068227.77621481,206.210678100586,230,2.31431115037568,0.710822548135411 +-147.0422,59.4217653,13.719616,392833.656764195,1068227.7598734,206.639785766602,230,2.31521394291153,0.714101748308273 +-146.97708,59.4182848,13.719616,396537.722424787,1068227.76520046,193.332321166992,230,2.28630446515668,0.609094273516211 +-146.91197,59.414772,13.719616,400241.987878901,1068227.79240056,194.56169128418,230,2.28905733284035,0.619093474689943 +-146.84688,59.411227,13.719616,403945.896315328,1068227.79198641,169.800354003906,140,2.22993859133657,0.404357331379439 +-146.7818,59.4076496,13.719616,407650.019569307,1068227.80167199,118.252296447754,140,2.07280958344709,-0.166380074359123 +-146.71674,59.40404,13.719616,411353.799609982,1068227.7820033,102.382797241211,140,2.01022699090896,-0.3936979133079 +-146.65169,59.4003981,13.719616,415057.807074668,1068227.78296094,95.2573547363281,41,1.97889851713603,-0.507491872087864 +-146.58665,59.3967239,13.719616,418762.048867862,1068227.80483355,92.9986877441406,41,1.9684768204948,-0.545346448937168 +-146.52163,59.3930175,13.719616,422465.968106796,1068227.79542299,75.1650161743164,41,1.87601575525144,-0.88119142891654 +-146.45663,59.3892789,13.719616,426169.571656336,1068227.75337445,37.0660438537598,41,1.56897623522922,-1.9964466034413 +-146.39163,59.385508,13.719616,429873.992710708,1068227.79570051,17.1879367828369,41,1.23522374768143,-3.20873090065901 +-146.32666,59.381705,13.719616,433577.548000154,1068227.75078187,32.6700019836426,41,1.51414916084474,-2.1955941868108 +-146.26169,59.3778697,13.719616,437281.934528135,1068227.79096042,111.35147857666,41,2.04669598817222,-0.261232105959581 +-146.19674,59.3740023,13.719616,440986.031501595,1068227.807701,148.434494018555,140,2.1715348363955,0.192218223342157 +-146.13181,59.3701026,13.719616,444689.848378072,1068227.77752289,171.467010498047,140,2.23418057605919,0.419765430674956 +-146.06689,59.3661709,13.719616,448393.950563424,1068227.79999657,174.597152709961,241,2.2420371570532,0.448302775336683 +-146.00199,59.3622069,13.719616,452097.786334604,1068227.77417329,278.895385742188,341,2.4454413290266,1.18712478527484 +-141.12268,58.9678259,13.719616,733601.725015844,1068227.76274573,675.857299804688,341,2.82985500888616,2.5834249931128 +-141.05929,58.9614257,13.719616,737305.782959374,1068227.77791936,403.355743408203,241,2.60568824526989,1.76918732409406 +-140.99592,58.9549944,13.719616,741010.059977303,1068227.830457,202,241,2.30535136944662,0.678278066425006 +-140.93258,58.9485321,13.719616,744713.997476646,1068227.81909709,189,142,2.27646180417324,0.573342919449214 +-140.86927,58.9420388,13.719616,748417.601540327,1068227.74208657,192,142,2.28330122870355,0.598185661509398 +-140.80597,58.9355144,13.719616,752122.005506782,1068227.81323263,191,142,2.28103336724773,0.589948141389748 +-140.74271,58.9289592,13.719616,755825.521247,1068227.72560137,186,142,2.26951294421792,0.548102676689368 +-140.67946,58.9223729,13.719616,759529.849028258,1068227.78603611,184,142,2.26481782300954,0.531048656339518 +-140.61624,58.9157557,13.719616,763233.865412798,1068227.78824472,181,142,2.25767857486918,0.505116869349467 +-140.55305,58.9091076,13.719616,766937.576424576,1068227.73053657,183,142,2.26245108973043,0.522452005536869 +-140.48988,58.9024286,13.719616,770641.550609351,1068227.72727582,189,142,2.27646180417324,0.573342919449214 +-140.42673,58.8957187,13.719616,774345.793979898,1068227.77847234,184,142,2.26481782300954,0.531048656339518 +-140.36361,58.8889779,13.719616,778049.750016005,1068227.76699286,185,142,2.26717172840301,0.539598712600118 +-140.30051,58.8822063,13.719616,781753.984957002,1068227.81985671,187,142,2.2718416065365,0.556561042896859 +-140.23744,58.8754038,13.719616,785457.944540141,1068227.80789668,175,142,2.24303804868629,0.451938299431001 +-140.1744,58.8685705,13.719616,789161.632445279,1068227.74044021,175,142,2.24303804868629,0.451938299431001 +-140.11138,58.8617064,13.719616,792865.617153123,1068227.73527245,174,142,2.2405492482826,0.442898265990424 +-140.04838,58.8548116,13.719616,796569.90228028,1068227.80340971,174,142,2.2405492482826,0.442898265990424 +-139.98541,58.8478859,13.719616,800273.935892992,1068227.80257973,172,142,2.23552844690755,0.42466128231685 +-139.92247,58.8409296,13.719616,803977.716903297,1068227.76400986,170,142,2.23044892137827,0.406210995753595 +-139.85955,58.8339425,13.719616,807681.818431038,1068227.78590513,167.758163452148,142,2.22468366300471,0.385269931772258 +-139.79666,58.8269247,13.719616,811385.681501081,1068227.75714965,165.764007568359,142,2.21949023784666,0.366405929247086 +-139.73379,58.8198762,13.719616,815089.874528628,1068227.7989479,163.502471923828,142,2.21352432295816,0.344736023530402 +-139.67095,58.812797,13.719616,818793.840868347,1068227.78816491,164.426803588867,142,2.2159726143105,0.353628916534049 +-139.60814,58.8056872,13.719616,822497.583993077,1068227.73421358,159.974594116211,142,2.20405101696075,0.310326272197087 +-139.54535,58.7985467,13.719616,826201.674683308,1068227.74909019,158.889007568359,142,2.20109385241481,0.299585006507447 +-139.48259,58.7913756,13.719616,829905.553852216,1068227.7189373,159.402786254883,142,2.20249590830567,0.30467767368964 +-139.41985,58.784174,13.719616,833609.787420636,1068227.77871569,157.700744628906,142,2.19783374397863,0.28774336213963 +-139.35714,58.7769417,13.719616,837313.823541352,1068227.7807392,152.732574462891,142,2.18393167229392,0.237247069734472 +-139.29446,58.7696789,13.719616,841017.663151509,1068227.74537855,163.679275512695,142,2.21399369407132,0.34644091338525 +-139.2318,58.7623856,13.719616,844721.874557724,1068227.7983902,203.359039306641,142,2.30826348155371,0.688855688797476 +-139.16917,58.7550617,13.719616,848425.903481378,1068227.80136724,226.127914428711,240,2.3543541772682,0.856270251226838 +-139.10657,58.7477073,13.719616,852129.753235032,1068227.76380026,232.761932373047,240,2.36691195401831,0.90188368072957 +-139.04399,58.7403225,13.719616,855833.989611613,1068227.82405222,232.336181640625,240,2.3661168476103,0.898995627309703 +-138.98144,58.7329072,13.719616,859538.058314691,1068227.84208122,223.71630859375,143,2.34969764468718,0.839356395785844 +-138.91892,58.7254614,13.719616,863241.965093823,1068227.81651147,152.554534912109,143,2.18342512222446,0.235407135298382 +-138.85643,58.7179852,13.719616,866945.713165922,1068227.75686754,123.410804748535,143,2.09135318431025,-0.0990244231534953 +-138.79396,58.7104786,13.719616,870649.870765197,1068227.79289174,113.627998352051,143,2.05548535630105,-0.22930661218027 +-138.73152,58.7029416,13.719616,874353.881065125,1068227.79325416,105.493766784668,40,2.02322679962427,-0.346478897539084 +-138.66911,58.6953743,13.719616,878057.74720322,1068227.76750236,105.117546081543,143,2.02167521393865,-0.352114699615902 +-138.60672,58.6877766,13.719616,881762.039932512,1068227.83620411,108.453552246094,143,2.03524378129822,-0.302829790111229 +-138.54437,58.6801486,13.719616,885465.637303279,1068227.74393803,122.413345336914,143,2.08782876658605,-0.111826114296761 +-138.48204,58.6724902,13.719616,889169.672604223,1068227.74463266,126.415176391602,143,2.10179921498655,-0.0610814581431596 +-138.41974,58.6648016,13.719616,892873.583782342,1068227.72597251,132.022079467773,143,2.12064656900235,0.00737751121263594 +-138.35746,58.6570827,13.719616,896577.941576626,1068227.81080814,132.898544311523,143,2.12352022397558,0.017815446298187 +-138.29522,58.6493336,13.719616,900281.623941689,1068227.73928818,107.535453796387,143,2.03155167215526,-0.316240584351337 +-138.233,58.6415542,13.719616,903985.764152058,1068227.76985465,108.055625915527,143,2.03364738334756,-0.308628363125377 +-138.17081,58.6337446,13.719616,907689.802657134,1068227.77712213,105.089973449707,143,2.02156128231571,-0.352528531789721 +-138.10865,58.6259048,13.719616,911393.745035844,1068227.75985358,93.3385848999023,40,1.9700612122892,-0.539591485709471 +-138.04652,58.6180349,13.719616,915097.594201899,1068227.72767946,105.95654296875,40,2.02512778018307,-0.339573993555663 +-137.98441,58.6101348,13.719616,918801.920888069,1068227.80687712,95.5795440673828,40,1.98036495452238,-0.502165352937743 +-137.92234,58.6022046,13.719616,922505.602920725,1068227.73095228,94.4076690673828,40,1.97500727500106,-0.521625974193144 +-137.86029,58.5942443,13.719616,926209.770878484,1068227.77596751,95.4604873657227,40,1.9798236472909,-0.504131535306944 +-137.79827,58.5862538,13.719616,929913.870451218,1068227.79154233,88.2646026611328,40,1.94578657049632,-0.627763913373773 +-137.73628,58.5782333,13.719616,933617.901761397,1068227.79819677,81.8842391967773,40,1.91320031826149,-0.746126482533092 +-137.67432,58.5701828,13.719616,937321.870283952,1068227.79476216,82.6620941162109,40,1.91730640326356,-0.731212009812229 +-137.61239,58.5621022,13.719616,941025.78421749,1068227.7692442,80.139892578125,40,1.90384875595594,-0.780094026028448 +-137.55049,58.5539917,13.6699861,944729.643574882,1068227.74217505,42.8926811218262,40,1.63238319382643,-1.76613443166844 +-137.48861,58.5458511,10.36815353,948434.021809577,1068227.83356175,13.3442716598511,40,1.12529487465857,-3.6080239443022 +-153.53582,59.5720293,13.24566771,26137.7101087281,1064523.77331066,12.3846569061279,32,1.09288397976809,-3.72574956553483 +-153.47004,59.5717814,13.719616,29841.8917141157,1064523.77800839,15.0494022369385,32,1.1775192500724,-3.41833010647839 +-153.40427,59.5715007,13.719616,33545.5687684734,1064523.77936047,17.9335689544678,32,1.253666726985,-3.14174073567807 +-153.33849,59.5711871,13.719616,37249.8748166985,1064523.77588543,20.1000003814697,32,1.30319606566279,-2.9618360405196 +-153.27272,59.5708408,13.719616,40953.6907399182,1064523.77945913,23.7999992370605,32,1.37657694313465,-2.69529574855413 +-153.20695,59.5704616,13.719616,44657.5871197536,1064523.77296164,25.6000003814697,32,1.40823997178334,-2.58028659097394 +-153.14118,59.5700496,13.719616,48361.571107153,1064523.76778386,29.2999992370605,32,1.46686760904556,-2.36733427844386 +-153.07541,59.5696049,13.719616,52065.6498083717,1064523.77533424,34.7000007629395,32,1.54032948433959,-2.10049977926921 +-153.00964,59.5691273,13.719616,55769.8307851851,1064523.7734968,38.0620956420898,32,1.58049269621427,-1.95461553001837 +-152.94388,59.568617,13.719616,59473.5578911112,1064523.77594146,40.5855484008789,32,1.60837141862557,-1.85335205284094 +-152.87811,59.5680738,13.719616,63177.9649014724,1064523.77794215,41.1095504760742,32,1.61394272789132,-1.83311546737774 +-152.81235,59.5674979,13.719616,66881.9325393735,1064523.78369118,44.7730751037598,32,1.65101692361576,-1.69845140647761 +-152.74659,59.5668891,13.719616,70586.0315382353,1064523.7801018,51.2629508972168,32,1.70980360226749,-1.48492141022591 +-152.68084,59.5662476,13.719616,74289.7056608354,1064523.77868389,56.2363510131836,32,1.75001713302436,-1.33885438843254 +-152.61509,59.5655732,13.719616,77993.5256836508,1064523.76750325,59.9568023681641,32,1.77783846288717,-1.23779937737266 +-152.54933,59.5648661,13.719616,81698.0614941248,1064523.78159326,66.0401382446289,32,1.81980797371881,-1.08535413474113 +-152.48359,59.5641262,13.719616,85401.631315934,1064523.77325937,55.5466041564941,32,1.74465751348074,-1.35832205640269 +-152.41784,59.5633535,13.719616,89105.9316605797,1064523.77981572,54.5184745788574,32,1.73654369581904,-1.3877937580641 +-152.3521,59.562548,13.719616,92809.8436132798,1064523.77541218,57.3539581298828,32,1.7585633949426,-1.30781192579949 +-152.28636,59.5617098,13.719616,96513.9372252762,1064523.78453133,47.8330459594727,32,1.67972803718122,-1.59416444704018 +-152.22063,59.5608387,13.719616,100217.65723122,1064523.77018893,42.8757934570312,32,1.63221217015454,-1.76675563845976 +-152.1549,59.5599349,13.719616,103921.573381119,1064523.76919702,36.6975517272949,32,1.56463709131494,-2.01220761265294 +-152.08917,59.5589983,13.719616,107625.693215562,1064523.77087643,42.1259765625,32,1.6245499817913,-1.79458689360134 +-152.02344,59.558029,13.719616,111330.02365296,1064523.78692117,42.7874336242676,32,1.63131623842962,-1.77000991820904 +-151.95772,59.5570268,13.719616,115034.009512862,1064523.77819076,37.4419746398926,32,1.57335874478281,-1.98052807784989 +-151.89201,59.555992,13.719616,118737.657013074,1064523.77709476,36.1118049621582,32,1.55764919613978,-2.037589642473 +-151.8263,59.5549243,13.719616,122441.537518349,1064523.76743852,55.9705505371094,32,1.74795957873186,-1.34632801290734 +-151.76059,59.5538239,13.719616,126145.657555063,1064523.77216326,76.3599624633789,32,1.88286570623353,-0.856310451778917 +-151.69488,59.5526907,13.719616,129850.024724178,1064523.78070005,81.5744476318359,32,1.9115541417151,-0.752105865615117 +-151.62919,59.5515248,13.719616,133553.519701365,1064523.7646285,86.8759002685547,32,1.93889931808323,-0.652780379955677 +-151.56349,59.5503261,13.719616,137257.839362762,1064523.77207369,125.084175109863,32,2.09720236886857,-0.0777785153141676 +-151.4978,59.5490947,13.58797517,140961.86435961,1064523.77409272,99.4188385009766,32,1.9974686850194,-0.440039721881825 +-151.43212,59.5478306,10.42061925,144665.601900205,1064523.76969038,26.2020454406738,32,1.41833519547714,-2.54361785705435 +-150.57872,59.5284189,10.47070934,192817.78933677,1064523.77100666,110.434715270996,33,2.04310561579085,-0.274273363243046 +-150.38193,59.5231546,12.27220105,203929.931484211,1064523.78340672,156.952545166016,33,2.19576836267763,0.280241307735883 +-150.25078,59.5194817,5.542846495,211337.563353279,1064523.76314367,37.6692352294922,33,1.57598680313443,-1.97098221979428 +-150.18521,59.5175963,11.97859865,215041.712018769,1064523.77570293,67.8239517211914,33,1.83138309008243,-1.04331000824132 +-150.11965,59.5156782,13.719616,218745.717091281,1064523.77461809,97.9319000244141,33,1.99092418054625,-0.463811230115858 +-150.0541,59.5137274,13.719616,222449.58574638,1064523.75926899,108.255409240723,33,2.03444960613122,-0.305714460997954 +-149.98855,59.5117441,13.719616,226153.886892833,1064523.78542935,116.677917480469,133,2.06698866903718,-0.187523296950285 +-149.92301,59.5097281,13.719616,229858.065923176,1064523.79725123,193.982437133789,133,2.28776241136754,0.61438995029333 +-149.85749,59.5076794,13.719616,233561.56692205,1064523.75899854,197.939315795898,133,2.29653206473378,0.646243834427776 +-149.79197,59.5055982,13.719616,237265.521811343,1064523.76222089,188.805297851562,133,2.27601417637846,0.571717007532877 +-149.72645,59.5034843,13.719616,240969.939128779,1064523.78573883,104.891326904297,33,2.02073957939158,-0.355513191347535 +-149.66095,59.5013378,13.719616,244673.699137744,1064523.76818476,87.9659576416016,33,1.94431463500496,-0.633110403210619 +-149.59545,59.4991587,13.719616,248377.935136974,1064523.78218726,97.0416946411133,33,1.98695837201823,-0.478216178644105 +-149.52997,59.496947,13.719616,252081.528082658,1064523.7530232,108.606086730957,133,2.03585416558056,-0.300612700176763 +-149.46449,59.4947028,13.719616,255785.610506213,1064523.76674276,119.161903381348,133,2.07613743161429,-0.154292379953404 +-149.39902,59.4924259,13.719616,259489.627959687,1064523.76318864,131.696151733398,133,2.11957308471601,0.0034783098817521 +-149.33356,59.4901165,13.719616,263193.586025847,1064523.76424305,190.730606079102,133,2.28042038882334,0.587721628790913 +-149.2681,59.4877745,13.719616,266898.055670444,1064523.79852888,215.134490966797,133,2.33271004328256,0.777652578740069 +-149.20266,59.4853999,13.719616,270601.917838591,1064523.78583346,233.225799560547,133,2.36777659062826,0.905024287688773 +-149.13723,59.4829928,13.719616,274305.741910403,1064523.77656408,210.268035888672,133,2.32277325798235,0.741559338288807 +-149.07181,59.4805531,13.719616,278009.53579258,1064523.75920979,197.377090454102,133,2.29529674272692,0.641756792302849 +-149.00639,59.4780809,13.719616,281713.86883856,1064523.7869999,188.37077331543,133,2.27501352068365,0.568082340433731 +-148.94099,59.4755761,13.719616,285417.622802036,1064523.76417843,183.476104736328,133,2.26357951132982,0.526550754869438 +-148.87559,59.4730388,13.719616,289121.930094756,1064523.78698539,174.779846191406,133,2.24249135282655,0.449952544025867 +-148.81021,59.470469,13.719616,292825.671614578,1064523.76861775,104.42504119873,33,2.01880465527906,-0.36254138800655 +-148.74483,59.4678666,13.719616,296529.981481176,1064523.78528421,88.7428817749023,33,1.94813352758785,-0.6192390953291 +-148.67947,59.4652318,13.719616,300233.738830626,1064523.77027931,83.6337890625,33,1.92238177311695,-0.712776817849936 +-148.61412,59.4625645,13.719616,303937.514681459,1064523.75631047,109.150497436523,133,2.03802571927965,-0.292724997318526 +-148.54877,59.4598646,13.719616,307641.880093501,1064523.77833692,113.074653625488,133,2.05336526607288,-0.237007385022966 +-148.48344,59.4571323,13.719616,311345.714129281,1064523.7663536,129.509567260742,133,2.11230185224022,-0.0229328818867051 +-148.41812,59.4543675,13.719616,315049.587832412,1064523.75479581,144.953384399414,133,2.16122835980023,0.154782158586853 +-148.3528,59.4515703,13.719616,318754.070388369,1064523.80263274,171.938049316406,133,2.23537199524203,0.424093005211927 +-148.2875,59.4487405,13.719616,322458.044562606,1064523.79199359,194.938568115234,133,2.28989777171151,0.622146188555144 +-148.22222,59.4458784,13.719616,326161.514517906,1064523.75449083,210.229248046875,133,2.32269313691451,0.741268315701604 +-148.15694,59.4429838,13.719616,329865.615365618,1064523.76539298,202.659423828125,133,2.30676680359409,0.683419327253735 +-148.09167,59.4400567,13.719616,333569.791059672,1064523.77604546,195.893325805664,133,2.29201963959275,0.629853418341201 +-148.02641,59.4370972,13.719616,337274.047631899,1064523.79750185,189.14208984375,133,2.2767881832759,0.574528421507922 +-147.96117,59.4341053,13.719616,340977.828997736,1064523.77835032,174.332321166992,133,2.2413779126589,0.445908211529492 +-147.89594,59.431081,13.719616,344681.705239957,1064523.76876782,149.741394042969,133,2.17534187194916,0.206046463109196 +-147.83072,59.4280243,13.719616,348385.683353327,1064523.76872036,140.026962280273,133,2.14621166740772,0.100237245626507 +-147.76551,59.4249352,13.719616,352089.770329691,1064523.77819107,121.673553466797,133,2.08519619177503,-0.121388377422038 +-147.70031,59.4218137,13.719616,355793.973157916,1064523.79718024,114.054824829102,133,2.0571136618383,-0.223392141704277 +-147.63513,59.4186598,13.719616,359497.735738781,1064523.77157298,115.177360534668,133,2.0613671217858,-0.20794236111663 +-147.56996,59.4154735,13.719616,363201.628140251,1064523.75442045,113.684532165527,133,2.05570137891699,-0.228521956380156 +-147.5048,59.4122549,13.719616,366905.656250322,1064523.75690186,113.855850219727,133,2.05635535074273,-0.226146544046952 +-147.43965,59.409004,13.719616,370609.827012969,1064523.77908249,116.355865478516,133,2.06578828088228,-0.191883449353779 +-147.37452,59.4057207,13.719616,374313.585397605,1064523.75355586,120.546127319336,133,2.08115326273621,-0.136073449657843 +-147.30939,59.4024051,13.719616,378018.063420381,1064523.80371749,197.829360961914,230,2.29629074811783,0.645367303600035 +-147.24429,59.3990572,13.719616,381721.57876057,1064523.75892079,194.523452758789,230,2.28897196961905,0.618783411105112 +-147.17919,59.3956769,13.719616,385425.828751241,1064523.77893939,188.56477355957,230,2.27546056391773,0.569706129058756 +-147.11411,59.3922644,13.719616,389129.69186858,1064523.77065367,196.158096313477,230,2.29260623809238,0.631984111523721 +-147.04904,59.3888195,13.719616,392833.740426217,1064523.76946595,202.756652832031,230,2.30697511314627,0.684175967004703 +-146.98398,59.3853424,13.719616,396537.979020433,1064523.79780082,203.859252929688,230,2.30933042834695,0.692731144087469 +-146.91894,59.381833,13.719616,400241.852641733,1064523.78447044,199.785949707031,140,2.3005649424522,0.660892397398963 +-146.85391,59.3782913,13.719616,403945.931290243,1064523.78884408,176.765914916992,140,2.24739852543626,0.467776795590846 +-146.7889,59.3747174,13.719616,407649.657580841,1064523.7608882,148.299896240234,140,2.17114084716925,0.190787142016694 +-146.7239,59.3711112,13.719616,411353.602696819,1064523.75000359,128.671310424805,140,2.10948172395838,-0.0331763927511183 +-146.65891,59.3674729,13.719616,415057.771076171,1064523.77868333,121.050674438477,140,2.08296721347286,-0.129484662829261 +-146.59394,59.3638022,13.719616,418761.610202855,1064523.75081412,113.607933044434,140,2.05540865846242,-0.229585200621913 +-146.52898,59.3600994,13.719616,422465.68632702,1064523.76197201,101.199172973633,41,2.00517696334908,-0.412041054826747 +-146.46403,59.3563644,13.719616,426170.00754391,1064523.80135848,80.2445831298828,41,1.90441572523639,-0.778034631772731 +-146.3991,59.3525972,13.719616,429874.017626733,1064523.80457498,67.1721572875977,41,1.82718929623758,-1.05854306451377 +-146.33419,59.3487978,13.719616,433577.723430235,1064523.77029568,118.39225769043,140,2.07332330245223,-0.16451410030245 +-146.26929,59.3449662,13.719616,437281.694890691,1064523.76305608,220.238693237305,140,2.34289362155313,0.814642241701417 +-146.2044,59.3411025,13.719616,440985.937546225,1064523.79434056,232.620574951172,241,2.36664812480592,0.900925377725804 +-146.13953,59.3372066,13.719616,444689.896443391,1064523.78647958,279.903503417969,341,2.44700833435601,1.19281659589913 +-146.07468,59.3332786,13.719616,448393.577091335,1064523.74931479,371.090911865234,341,2.56948031846867,1.63766979918082 +-146.00984,59.3293185,13.719616,452097.549379211,1064523.74967482,437.052124023438,440,2.64053323519883,1.89575427326629 +-141.07179,58.9289172,13.719616,737305.575090839,1064523.73306079,666,341,2.8234742291703,2.56024817992894 +-141.00848,58.9224919,13.719616,741009.742350603,1064523.76219303,420,241,2.6232492903979,1.83297405242031 +-140.9452,58.9160357,13.719616,744713.564344788,1064523.73452782,194,142,2.28780172993023,0.614532766535627 +-140.88194,58.9095484,13.719616,748417.61459575,1064523.73907189,194,142,2.28780172993023,0.614532766535627 +-140.8187,58.9030302,13.719616,752121.894802174,1064523.79767653,191,142,2.28103336724773,0.589948141389748 +-140.75549,58.896481,13.719616,755825.850132383,1064523.78550952,187,142,2.2718416065365,0.556561042896859 +-140.6923,58.8899009,13.719616,759530.047511129,1064523.82617497,180,142,2.25527250510331,0.496377337199112 +-140.62914,58.8832899,13.719616,763233.929881133,1064523.80470922,177,142,2.24797326636181,0.46986441867983 +-140.566,58.876648,13.719616,766938.066349777,1064523.83489833,183,142,2.26245108973043,0.522452005536869 +-140.50289,58.8699752,13.719616,770641.899848664,1064523.80069045,183,142,2.26245108973043,0.522452005536869 +-140.4398,58.8632715,13.719616,774345.999474008,1064523.81701431,184,142,2.26481782300954,0.531048656339518 +-140.37674,58.856537,13.719616,778049.805869247,1064523.77767338,183,142,2.26245108973043,0.522452005536869 +-140.3137,58.8497717,13.719616,781753.888088208,1064523.79873234,181,142,2.25767857486918,0.505116869349467 +-140.25069,58.8429755,13.719616,785457.691306572,1064523.75101683,178,142,2.25042000230889,0.478751662007618 +-140.1877,58.8361486,13.719616,789161.779981856,1064523.77361443,177,142,2.24797326636181,0.46986441867983 +-140.12474,58.8292909,13.719616,792865.599268052,1064523.7362599,176,142,2.24551266781415,0.460926822429992 +-140.0618,58.8224024,13.719616,796569.718196342,1064523.75730252,175,142,2.24303804868629,0.451938299431001 +-139.99889,58.8154832,13.719616,800273.577282855,1064523.72725989,174,142,2.2405492482826,0.442898265990424 +-139.936,58.8085333,13.719616,803977.745516297,1064523.76561661,171,142,2.23299611039215,0.415463113292133 +-139.87314,58.8015527,13.719616,807681.665709437,1064523.75086433,172.307586669922,142,2.23630439977157,0.427479764597974 +-139.8103,58.7945414,13.719616,811385.906839508,1064523.80362956,171.899993896484,142,2.23527586126691,0.423743819174916 +-139.74749,58.7874994,13.719616,815089.911707763,1064523.80131487,169.8984375,142,2.23018938482403,0.405268284909469 +-139.68471,58.7804268,13.719616,818793.683804018,1064523.75331552,169.024459838867,142,2.22794955671066,0.397132589891121 +-139.62195,58.7733235,13.719616,822497.794458268,1064523.77104728,166.218460083008,142,2.22067925450815,0.370724777140774 +-139.55922,58.7661897,13.719616,826201.681631627,1064523.75210707,163.699432373047,142,2.21404717350063,0.34663516593708 +-139.49651,58.7590253,13.719616,829905.916632176,1064523.80904981,162.697357177734,142,2.21138049840429,0.336949040842313 +-139.43383,58.7518302,13.719616,833609.944633115,1064523.80563817,160.321334838867,142,2.20499132014736,0.313741721760107 +-139.37118,58.7446047,13.719616,837313.764159154,1064523.7731352,168.691162109375,142,2.22709233008365,0.394018898104994 +-139.30855,58.7373486,13.719616,841017.948953349,1064523.81490296,210.777099609375,142,2.32382342412334,0.745373841460155 +-139.24595,58.7300619,13.719616,844721.941739337,1064523.80397906,237.314712524414,240,2.37532466350221,0.932441042801443 +-139.18338,58.7227448,13.719616,848425.7433739,1064523.76073679,239.819564819336,240,2.37988461056631,0.949004072076698 +-139.12083,58.7153972,13.719616,852129.925160761,1064523.80116163,240.886871337891,240,2.3818131310034,0.956009008758769 +-139.05831,58.7080192,13.719616,855833.927281497,1064523.80754444,225.691268920898,240,2.35351475831206,0.853221241984087 +-138.99582,58.7006107,13.719616,859537.757963391,1064523.76758942,173.158447265625,143,2.23844368278333,0.435250251108857 +-138.93335,58.6931718,13.719616,863241.983525844,1064523.82078861,117.641181945801,143,2.0705593792315,-0.17455345834236 +-138.87091,58.6857025,13.719616,866946.046595375,1064523.83689507,108.545936584473,143,2.03561357028724,-0.301486610954823 +-138.8085,58.6782028,13.719616,870649.95287763,1064523.81454365,107.695953369141,143,2.0321993851692,-0.313887905808996 +-138.74612,58.6706727,13.719616,874353.708072253,1064523.75238173,102.804443359375,40,2.01201188591173,-0.387214665198088 +-138.68376,58.6631123,13.719616,878057.878403129,1064523.79216545,101.228996276855,143,2.00530493067857,-0.411576240960557 +-138.62143,58.6555216,13.719616,881761.906442148,1064523.80145965,108.785675048828,143,2.03657171101622,-0.298006370346572 +-138.55913,58.6479006,13.719616,885465.797840294,1064523.77894164,111.445602416992,143,2.04706293612972,-0.259899246240573 +-138.49686,58.6402493,13.719616,889169.558242506,1064523.72330109,121.911575317383,143,2.08604494317212,-0.118305470090035 +-138.43461,58.6325677,13.719616,892873.756372777,1064523.76768655,125.206916809082,143,2.0976283212789,-0.0762313345809332 +-138.37239,58.6248559,13.719616,896577.832173026,1064523.78834955,131.553146362305,143,2.11910123958589,0.00176443369112605 +-138.3102,58.6171138,13.719616,900281.793855409,1064523.77314327,136.17399597168,143,2.13409418184811,0.0562230793992984 +-138.24804,58.6093416,13.719616,903985.641788337,1064523.74253311,113.343292236328,143,2.05439582326317,-0.233264107157528 +-138.1859,58.6015391,13.719616,907689.949882978,1064523.81021075,113.623542785645,143,2.05546832646798,-0.229368469394747 +-138.1238,58.5937065,13.719616,911393.592284687,1064523.7238585,112.474029541016,143,2.05105225463334,-0.245408902770582 +-138.06172,58.5858438,13.719616,915097.700705034,1064523.75614906,106.651626586914,143,2.02796748343603,-0.329259380808908 +-137.99967,58.5779509,13.719616,918801.720260796,1064523.75832367,112.349884033203,143,2.05057262847953,-0.247151041860149 +-137.93765,58.5700279,13.719616,922505.653834668,1064523.74002451,118.104080200195,143,2.07226490165941,-0.168358514079623 +-137.87565,58.5620748,13.719616,926210.070034674,1064523.83951367,119.222091674805,143,2.07635673697724,-0.153495800279175 +-137.81369,58.5540917,13.719616,929913.845510369,1064523.7880697,122.202926635742,143,2.087081606942,-0.114540011384539 +-137.75176,58.5460785,13.719616,933617.551534194,1064523.71257007,130.617309570312,143,2.11600073400443,-0.00949748755313484 +-137.68985,58.5380353,13.719616,937321.753978436,1064523.76382594,149.470947265625,143,2.17455678685194,0.203194809950464 +-137.62797,58.5299621,13.719616,941025.895225852,1064523.80064887,158.969757080078,143,2.20131451059392,0.300386499996077 +-137.56612,58.5218589,13.719616,944729.980738102,1064523.82188599,132.960586547852,143,2.12372292230897,0.0185517045009385 +-137.5043,58.5137258,13.719616,948434.013223201,1064523.83722873,94.1345901489258,40,1.9737492360783,-0.526195530640673 +-137.44251,58.5055626,13.67115043,952138.003615087,1064523.82387987,35.4985809326172,40,1.55021099233814,-2.06460732175529 +-137.38075,58.4973696,9.429639156,955841.949084263,1064523.81321134,11.1680173873901,40,1.04797608142895,-3.88886787029292 +-153.53628,59.5389049,13.719616,26137.6708092689,1060819.77175013,13.9304256439209,32,1.14396438648728,-3.54021094853114 +-153.47057,59.5386572,13.719616,29841.5753461826,1060819.76949444,17.5336971282959,32,1.24387350041349,-3.17731252985093 +-153.40486,59.5383768,13.719616,33545.5382425828,1060819.77599436,22.1970977783203,32,1.3462961951148,-2.80528406834819 +-153.33915,59.5380635,13.719616,37249.5669473906,1060819.76904201,23.7999992370605,32,1.37657694313465,-2.69529574855413 +-153.27344,59.5377175,13.719616,40953.6685084178,1060819.77117279,25.6000003814697,32,1.40823997178334,-2.58028659097394 +-153.20773,59.5373387,13.719616,44657.8502848207,1060819.77139639,29.2999992370605,32,1.46686760904556,-2.36733427844386 +-153.14203,59.5369272,13.719616,48361.555747891,1060819.77382049,32.2929840087891,32,1.50910817752488,-2.21390447706842 +-153.07632,59.5364829,13.719616,52065.9195638458,1060819.7814978,36.5999984741211,32,1.56348106728838,-2.01640662187954 +-153.01062,59.5360058,13.719616,55769.8217047721,1060819.77955142,39.850456237793,32,1.60043329788826,-1.88218557312409 +-152.94492,59.5354959,13.719616,59473.8330708192,1060819.77552685,42.1726760864258,32,1.625031160244,-1.79283911611913 +-152.87922,59.5349533,13.719616,63177.9607301108,1060819.78088561,41.5849609375,32,1.61893629786855,-1.81497739591367 +-152.81353,59.5343779,13.719616,66881.648462676,1060819.77467576,50.7894515991211,32,1.70577352354407,-1.49955980644837 +-152.74783,59.5337697,13.719616,70586.0308099415,1060819.77679886,57.5695610046387,32,1.76019291776519,-1.3018930337957 +-152.68214,59.5331288,13.719616,74289.9875194877,1060819.77807048,62.0058364868164,32,1.79243257070339,-1.18478941221106 +-152.61646,59.5324551,13.719616,77993.5260456021,1060819.76599111,73.5705108642578,32,1.86670377173854,-0.915015210940082 +-152.55077,59.5317487,13.719616,81697.7806838534,1060819.77504193,59.1860198974609,32,1.77221913580411,-1.25821037725397 +-152.48509,59.5310095,13.719616,85401.6316236089,1060819.77038726,55.4673614501953,32,1.74403750723678,-1.36057409604816 +-152.41941,59.5302376,13.719616,89105.6494940789,1060819.77535747,54.023853302002,32,1.73258555741741,-1.40217084650399 +-152.35373,59.5294329,13.719616,92809.8417909604,1060819.77919933,55.9063377380371,32,1.74746104381912,-1.34813883400645 +-152.28806,59.5285954,13.719616,96513.6521223363,1060819.76782393,69.7507476806641,32,1.84354886731261,-0.999120432882788 +-152.22239,59.5277253,13.719616,100217.650782634,1060819.77746584,42.3253021240234,32,1.62660006684779,-1.78714039952365 +-152.15672,59.5268223,13.719616,103921.845885733,1060819.77507104,39.2117500305176,32,1.59341622540749,-1.90767358324614 +-152.09106,59.5258866,13.719616,107625.680427594,1060819.76728653,40.1349639892578,32,1.60352287764608,-1.87096333758984 +-152.0254,59.5249182,13.719616,111329.725265363,1060819.76971786,44.072582244873,32,1.64416849688716,-1.72332684709146 +-151.95974,59.5239171,13.719616,115033.987612402,1060819.78289798,47.7121696472168,32,1.67862916596973,-1.59815586092936 +-151.89409,59.5228832,13.719616,118737.911392768,1060819.77832254,70.2526168823242,32,1.84666250617692,-0.987810807806604 +-151.82844,59.5218166,13.719616,122442.067128263,1060819.78450095,66.4103317260742,32,1.82223564958749,-1.0765361230584 +-151.7628,59.5207173,13.719616,126145.898386377,1060819.78302537,93.3813858032227,32,1.97026031468182,-0.53886828899001 +-151.69716,59.5195852,13.719616,129849.976406867,1060819.78120488,108.511215209961,32,2.03547462714385,-0.301991292109947 +-151.63153,59.5184204,13.719616,133553.744389481,1060819.77072775,111.806465148926,32,2.04846691712216,-0.25479958653996 +-151.5659,59.5172229,13.719616,137257.773184077,1060819.77122941,83.5000839233398,32,1.92168691197971,-0.715300751833488 +-150.5821,59.4953371,8.36485851,192817.758643074,1060819.77762529,46.6177368164062,33,1.66855118570098,-1.63476196180742 +-150.51656,59.4936166,7.27430276,196521.865494801,1060819.77527603,27.9403018951416,33,1.44623109435818,-2.44229199003614 +-150.45103,59.4918636,6.898639954,200225.79059104,1060819.77967383,77.9944839477539,33,1.89206388889865,-0.82290002691648 +-150.38551,59.4900779,10.94824071,203929.542263261,1060819.76777407,45.4625091552734,33,1.65765340152132,-1.67434582448523 +-150.18898,59.4845249,13.719616,215041.517524478,1060819.7580751,95.5836410522461,133,1.98038357000964,-0.502097736174616 +-150.12348,59.4826087,13.719616,218745.772571353,1060819.77526401,105.590156555176,133,2.02362343379414,-0.345038209023462 +-150.05799,59.4806599,13.719616,222449.889343208,1060819.78625494,114.739761352539,33,2.05971394225739,-0.213947181028221 +-149.99251,59.4786784,13.719616,226153.875651439,1060819.77928003,145.766342163086,133,2.16365725580422,0.163604602149257 +-149.92704,59.4766644,13.719616,229857.737293549,1060819.77607318,184.462951660156,133,2.26590915366456,0.535012680775335 +-149.86157,59.4746177,13.719616,233562.046405209,1060819.78891058,198.152465820312,133,2.29699948108854,0.647941624042165 +-149.79612,59.4725385,13.719616,237265.681450267,1060819.76977814,199.199249267578,133,2.29928769734289,0.656253078599909 +-149.73067,59.4704267,13.719616,240969.777528905,1060819.77787528,145.590667724609,133,2.16313353785065,0.161702309057926 +-149.66523,59.4682823,13.719616,244673.778125388,1060819.77751438,89.5266876220703,33,1.95195251642557,-0.605367437822557 +-149.5998,59.4661053,13.719616,248377.690364742,1060819.7681945,93.0518112182617,33,1.96872483092666,-0.544445604259444 +-149.53438,59.4638958,13.719616,252081.520618569,1060819.76058848,99.4088973999023,133,1.99742525681936,-0.440197465500016 +-149.46896,59.4616537,13.719616,255785.840379792,1060819.78158844,114.673736572266,133,2.05946396395365,-0.214855173578321 +-149.40356,59.459379,13.719616,259489.529481294,1060819.75427287,124.9326171875,133,2.09667583801575,-0.0796910256584652 +-149.33816,59.4570718,13.719616,263193.721540881,1060819.76695377,161.978775024414,133,2.20945811026063,0.329966378400315 +-149.27277,59.4547321,13.719616,266897.859996879,1060819.78070011,194.748764038086,133,2.28947471012821,0.620609508130793 +-149.20739,59.4523598,13.719616,270601.952734413,1060819.78396169,212.693130493164,133,2.32775346340019,0.759648865858567 +-149.14202,59.449955,13.719616,274306.006045842,1060819.78751182,217.722412109375,133,2.33790313714599,0.796515377908632 +-149.07666,59.4475177,13.719616,278010.027005449,1060819.79098745,202.170883178711,133,2.30571860830066,0.679611982763264 +-149.01131,59.4450479,13.719616,281714.022685164,1060819.79404294,195.313613891602,133,2.29073251585282,0.625178217536086 +-148.94597,59.4425456,13.719616,285418.000154526,1060819.79635009,194.426391601562,133,2.28875521608912,0.617996100416784 +-148.88064,59.4400107,13.719616,289121.967341721,1060819.78645002,187.697021484375,133,2.2734573809689,0.562429996823287 +-148.81532,59.4374434,13.719616,292825.929600251,1060819.78634635,106.652877807617,133,2.02797257848311,-0.329240874143612 +-148.75001,59.4348436,13.719616,296529.894842407,1060819.7846141,91.4958038330078,33,1.96140117697401,-0.571047205794404 +-148.68471,59.4322113,13.719616,300233.87012786,1060819.78099466,85.6970825195312,33,1.93296603700796,-0.674331750348096 +-148.61942,59.4295466,13.719616,303937.86160884,1060819.78639124,89.5999984741211,33,1.95230800226613,-0.604076211783878 +-148.55414,59.4268493,13.719616,307641.878138761,1060819.77828986,100.418350219727,133,2.00181308204177,-0.424259631882239 +-148.48887,59.4241197,13.719616,311345.924022003,1060819.78991481,118.663986206055,133,2.07431893323298,-0.160897685125425 +-148.42361,59.4213576,13.719616,315050.008117709,1060819.79878758,138.256805419922,133,2.14068651779646,0.0801683252037147 +-148.35837,59.418563,13.719616,318753.573829699,1060819.75673899,152.662261962891,133,2.18373169293831,0.236520687635085 +-148.29313,59.415736,13.719616,322457.754527981,1060819.77019057,183.647384643555,133,2.26398474785714,0.528022689602675 +-148.2279,59.4128766,13.719616,326161.993578121,1060819.79156259,198.197204589844,133,2.29709752482248,0.648297746868315 +-148.16269,59.4099848,13.719616,329865.734342951,1060819.77106144,207.533721923828,133,2.31708867480969,0.720911309664165 +-148.09749,59.4070606,13.719616,333569.547468207,1060819.75713596,185.608047485352,133,2.26859680217764,0.5447749873061 +-148.03229,59.404104,13.719616,337274.003596829,1060819.80048301,164.334884643555,133,2.21572976428752,0.352746815934272 +-147.96711,59.4011149,13.719616,340977.983454696,1060819.78888202,161.096328735352,133,2.2070856432861,0.321348901179327 +-147.90194,59.3980935,13.719616,344682.05566134,1060819.79477742,164.908905029297,133,2.21724410804393,0.358247344694309 +-147.83679,59.3950398,13.719616,348385.663532634,1060819.76566965,157.919479370117,133,2.19843570354328,0.289929851094813 +-147.77164,59.3919537,13.719616,352089.942357157,1060819.79476356,139.014266967773,133,2.14305937397652,0.0887872161302657 +-147.70651,59.3888352,13.719616,355793.77183483,1060819.77658006,124.900299072266,133,2.0965634782883,-0.0800991482592411 +-147.64139,59.3856843,13.719616,359497.72259113,1060819.76359185,115.92162322998,133,2.06416445385449,-0.197781652605093 +-147.57628,59.3825012,13.719616,363201.79944603,1060819.77808721,116.904815673828,133,2.06783240147402,-0.184458619914481 +-147.51118,59.3792857,13.719616,366906.011492095,1060819.79785214,114.524017333984,133,2.05889657402805,-0.216916095737328 +-147.4461,59.3760379,13.719616,370609.800958355,1060819.77827251,119.078598022461,133,2.07583371281804,-0.155395573311353 +-147.38103,59.3727578,13.719616,374313.73842534,1060819.77411678,119.41332244873,133,2.07705278192907,-0.150967566343147 +-147.31597,59.3694453,13.719616,378017.831951041,1060819.77435597,184.895172119141,133,2.266925571249,0.538704599556504 +-147.25093,59.3661006,13.719616,381721.522588072,1060819.74387356,186.872497558594,134,2.27154538999615,0.555485099873705 +-147.18589,59.3627236,13.719616,385425.945662888,1060819.78607282,192.852798461914,134,2.28522594523861,0.605176781333541 +-147.12087,59.3593144,13.719616,389129.979658728,1060819.79670574,196.461990356445,134,2.29327853957048,0.634426102386144 +-147.05587,59.3558729,13.719616,392833.632631696,1060819.76313874,187.453659057617,230,2.272893922181,0.560383353678482 +-146.99087,59.3523991,13.719616,396538.038786,1060819.80329756,197.992584228516,230,2.29664892415573,0.646668301203311 +-146.9259,59.3488931,13.719616,400241.512919594,1060819.74936736,195.31282043457,140,2.29073075153797,0.62517180904095 +-146.86093,59.3453548,13.719616,403945.754039888,1060819.76957047,186.375869750977,140,2.27038968316618,0.55128724279567 +-146.79598,59.3417843,13.719616,407649.640559246,1060819.75415966,171.955871582031,140,2.2354170097721,0.424256510833593 +-146.73104,59.3381817,13.719616,411353.741771723,1060819.77475938,168.870956420898,140,2.22755496306567,0.395699313144285 +-146.66611,59.3345468,13.719616,415058.066978283,1060819.80940063,162.719543457031,140,2.21143971707836,0.337164139969222 +-146.6012,59.3308797,13.719616,418762.058191326,1060819.806419,159.304611206055,140,2.20222834700239,0.303705814666519 +-146.53631,59.3271804,13.719616,422465.72227311,1060819.76443456,146.439086914062,140,2.16565701227846,0.170868288451038 +-146.47143,59.323449,13.719616,426169.628460478,1060819.75736444,143.015396118164,140,2.15538279333386,0.133549392690208 +-146.40656,59.3196854,13.719616,429873.784851757,1060819.77442366,148.571762084961,241,2.17193627418882,0.193676359989253 +-146.34171,59.3158897,13.719616,433577.633369357,1060819.76177471,230.889251708984,341,2.36340371623408,0.889140759746491 +-146.27687,59.3120618,13.719616,437281.745769039,1060819.77283977,410.789459228516,341,2.61361929116277,1.79799514652289 +-146.21205,59.3082018,13.719616,440985.563944366,1060819.75269636,514.005676269531,341,2.71096791502431,2.15159313445158 +-141.02101,58.8899877,13.719616,741009.764856167,1060819.77511987,553,341,2.7427251313047,2.26694440839392 +-140.95778,58.8835374,13.719616,744714.033117436,1060819.82199923,215,241,2.33243845991561,0.776666110433694 +-140.89458,58.8770562,13.719616,748417.958622101,1060819.80756155,195,142,2.29003461136252,0.622643229225523 +-140.83141,58.8705441,13.719616,752121.547412768,1060819.73004785,192,142,2.28330122870355,0.598185661509398 +-140.76825,58.864001,13.719616,755825.935024674,1060819.80437644,189,142,2.27646180417324,0.573342919449214 +-140.70512,58.857427,13.719616,759529.998012184,1060819.81438741,188,142,2.27415784926368,0.564974297603475 +-140.64202,58.8508222,13.719616,763233.740168204,1060819.76931544,188,142,2.27415784926368,0.564974297603475 +-140.57894,58.8441864,13.719616,766937.735612165,1060819.76103248,186,142,2.26951294421792,0.548102676689368 +-140.51588,58.8375198,13.719616,770641.985882274,1060819.81142407,188,142,2.27415784926368,0.564974297603475 +-140.45285,58.8308224,13.719616,774345.933313965,1060819.80388089,187,142,2.2718416065365,0.556561042896859 +-140.38985,58.8240942,13.719616,778049.583879938,1060819.73673288,188,142,2.27415784926368,0.564974297603475 +-140.32687,58.8173351,13.719616,781753.509475248,1060819.71509618,186,142,2.26951294421792,0.548102676689368 +-140.26391,58.8105453,13.719616,785457.711501527,1060819.76088631,182,142,2.26007138798507,0.513808249563239 +-140.20098,58.8037247,13.719616,789161.634546511,1060819.74437302,182,142,2.26007138798507,0.513808249563239 +-140.13807,58.7968733,13.719616,792865.848203224,1060819.78332755,181,142,2.25767857486918,0.505116869349467 +-140.07519,58.7899913,13.719616,796569.790120265,1060819.77974017,180,142,2.25527250510331,0.496377337199112 +-140.01233,58.7830785,13.719616,800274.034490955,1060819.83064986,179,142,2.25285303097989,0.487589116596209 +-139.9495,58.776135,13.719616,803978.021258353,1060819.82602074,178.425476074219,142,2.2514568642135,0.482517840394997 +-139.8867,58.7691608,13.719616,807681.756318811,1060819.76428282,175.639739990234,142,2.24462278552134,0.457694515944808 +-139.82392,58.762156,13.719616,811385.806837964,1060819.77697927,173.981719970703,142,2.24050361993258,0.442732530799517 +-139.76117,58.7551206,13.719616,815089.615026891,1060819.74149872,174.704528808594,142,2.24230416320324,0.449272617884792 +-139.69844,58.7480545,13.719616,818793.752765063,1060819.76867645,174.630294799805,142,2.2421195871536,0.448602184989246 +-139.63574,58.7409578,13.719616,822497.659884198,1060819.74573542,174.718933105469,142,2.24233996907969,0.449402675048054 +-139.57306,58.7338305,13.719616,826201.905863745,1060819.79557151,169.748733520508,142,2.22980654273394,0.403877693164265 +-139.51041,58.7266727,13.719616,829905.930472334,1060819.80430665,170.766693115234,142,2.23240316842078,0.41330937880961 +-139.44779,58.7194843,13.719616,833609.74193369,1060819.75953862,172.847671508789,142,2.23766353338554,0.432416525819263 +-139.38519,58.7122654,13.719616,837313.90726991,1060819.79678278,220.759750366211,142,2.34391989429593,0.818369957230681 +-139.32262,58.705016,13.719616,841017.868620608,1060819.78960741,242.835098266602,240,2.38531145786401,0.968715930438412 +-139.26008,58.6977361,13.719616,844721.631762381,1060819.7365586,245.951568603516,240,2.39084959670092,0.988832031436235 +-139.19756,58.6904258,13.719616,848425.763638148,1060819.77484924,245.082183837891,240,2.38931174151678,0.983246102459878 +-139.13507,58.6830849,13.719616,852129.711300911,1060819.75460968,231.174911499023,240,2.36394070003936,0.891091238197698 +-139.0726,58.6757137,13.719616,855834.036709778,1060819.83598726,180.292098999023,143,2.25597669490703,0.498935155562022 +-139.01017,58.668312,13.719616,859537.623273329,1060819.73859765,124.591529846191,143,2.0954885185182,-0.0840037089683107 +-138.94776,58.6608799,13.719616,863241.60151269,1060819.73023733,117.568923950195,143,2.07029254333487,-0.175522682481483 +-138.88537,58.6534175,13.719616,866945.974616454,1060819.82208284,110.724876403809,143,2.04424520417762,-0.270134052951364 +-138.82302,58.6459247,13.719616,870649.623504721,1060819.74134147,105.079254150391,143,2.02151698151488,-0.352689444943071 +-138.76069,58.6384015,13.719616,874353.68116163,1060819.74829575,100.609130859375,40,2.0026373972397,-0.421265483800365 +-138.69839,58.630848,13.719616,878057.587084368,1060819.72193685,100.280792236328,40,2.00121775630439,-0.426422024883259 +-138.63611,58.6232643,13.719616,881761.908009021,1060819.8045743,106.530723571777,40,2.02747487682099,-0.331048668638656 +-138.57387,58.6156502,13.719616,885465.527414735,1060819.70812944,115.421646118164,143,2.06228726382932,-0.204600142579889 +-138.51165,58.6080059,13.719616,889169.573095645,1060819.71914369,118.843826293945,143,2.07497662589497,-0.15850875765292 +-138.44945,58.6003314,13.719616,892874.050658985,1060819.83797744,122.5,143,2.08813608870055,-0.110709832658411 +-138.38729,58.5926266,13.719616,896577.841023567,1060819.78412596,122.534820556641,143,2.088259519123,-0.110261498133539 +-138.32516,58.5848917,13.719616,900281.508230981,1060819.71192956,125.810989379883,143,2.09971857766407,-0.0686389267714318 +-138.26305,58.5771265,13.719616,903985.626729869,1060819.73449684,131.389755249023,143,2.11856150363874,-0.000196041324887361 +-138.20097,58.5693312,13.719616,907689.633223353,1060819.73728927,132.777725219727,143,2.12312522393597,0.0163806934101173 +-138.13892,58.5615057,13.719616,911393.535901762,1060819.70818859,132.375442504883,143,2.12180742487839,0.0115940710956901 +-138.07689,58.5536502,13.719616,915097.898670729,1060819.80546007,131.182601928711,143,2.11787624062361,-0.0026851121893897 +-138.0149,58.5457645,13.719616,918801.605076655,1060819.73112511,130.877395629883,143,2.11686464425188,-0.00635951894986339 +-137.95293,58.5378487,13.719616,922505.785289496,1060819.77096244,135.672119140625,143,2.13249060854808,0.0503984434682015 +-137.89099,58.5299029,13.719616,926209.878504054,1060819.79681588,139.162048339844,143,2.14352081254569,0.0904632927211662 +-137.82908,58.521927,13.719616,929913.892900252,1060819.79663199,145.334426879883,143,2.16236850234327,0.158923481732252 +-137.7672,58.5139211,13.719616,933617.831283223,1060819.78006614,162.037155151367,143,2.20961460977131,0.330534829292522 +-137.70535,58.5058853,13.719616,937321.696411547,1060819.75677519,166.517959594727,143,2.22146108067871,0.373564592947626 +-137.64352,58.4978194,13.719616,941026.06281417,1060819.84560003,176.894241333008,143,2.24771369498996,0.468921581368242 +-137.58173,58.4897236,13.719616,944729.80322695,1060819.78422253,178.565353393555,143,2.25179719761159,0.483754028437681 +-137.51996,58.4815978,13.719616,948434.053104745,1060819.84460521,150.673568725586,143,2.17803707472079,0.215836208863186 +-137.45823,58.4734421,13.719616,952137.687855371,1060819.75137371,123.534873962402,143,2.09178957647367,-0.0974393222572196 +-137.39652,58.4652565,13.719616,955841.840176455,1060819.78957766,104.034454345703,143,2.0171771936656,-0.368452793110421 +-137.33484,58.457041,13.719616,959545.951830857,1060819.81528254,66.9864349365234,40,1.82598686495941,-1.06291063812414 +-137.27319,58.4487957,11.53287653,963250.025433059,1060819.83820043,29.5089263916016,40,1.46995340907011,-2.35612577197971 +-153.60238,59.5059948,13.719616,22434.0116412422,1057115.77700325,14.0722742080688,32,1.14836428906246,-3.52422924652085 +-153.53674,59.5057801,13.719616,26137.5801681553,1057115.77444737,17.1836051940918,32,1.23511428590045,-3.20912849709102 +-153.47109,59.5055327,13.719616,29841.7639358699,1057115.78086679,21.0475826263428,32,1.32320222310152,-2.88916796637627 +-153.40544,59.5052525,13.719616,33546.0060668509,1057115.78183852,24.4112529754639,32,1.38759007136165,-2.65529292337389 +-153.3398,59.5049395,13.719616,37249.7496163556,1057115.77190805,26.0920257568359,32,1.416507798566,-2.5502554842266 +-153.27416,59.5045939,13.719616,40953.5657960934,1057115.77810329,29.2999992370605,32,1.46686760904556,-2.36733427844386 +-153.20851,59.5042154,13.719616,44658.0263953293,1057115.77379614,31.1000003814697,32,1.49276039435385,-2.27328429166744 +-153.14287,59.5038043,13.719616,48362.0098679769,1057115.77984643,34.7000007629395,32,1.54032948433959,-2.10049977926921 +-153.07724,59.5033604,13.719616,52065.5237129132,1057115.77244576,40.2000007629395,32,1.60422606132677,-1.86840917375296 +-153.0116,59.5028838,13.719616,55769.7034189315,1057115.77814124,41.0806922912598,32,1.61363775371153,-1.83422322064706 +-152.94596,59.5023744,13.719616,59473.9921833343,1057115.77873281,41.9872817993164,32,1.62311775990184,-1.79978913230068 +-152.88033,59.5018323,13.719616,63177.8328701207,1057115.77616803,49.0065460205078,32,1.69025409453274,-1.55593080230356 +-152.8147,59.5012575,13.719616,66881.7968992867,1057115.77914285,50.1541290283203,32,1.70030669289778,-1.5194168957445 +-152.74907,59.5006499,13.719616,70585.8917003029,1057115.77679389,63.798152923584,32,1.8048081052618,-1.13983793836569 +-152.68345,59.5000096,13.719616,74289.5601023533,1057115.76944902,62.7714729309082,32,1.7977623194785,-1.16543024339811 +-152.61782,59.4993366,13.719616,77993.9377242603,1057115.77927543,61.7795791625977,32,1.79084494559729,-1.19055611974977 +-152.5522,59.4986309,13.719616,81697.9033818649,1057115.78371287,64.9319229125977,32,1.81245826438461,-1.11205037685885 +-152.48658,59.4978924,13.719616,85402.0287468635,1057115.78315717,58.6726264953613,32,1.76843552995675,-1.27195351364021 +-152.42097,59.4971212,13.719616,89105.7566015787,1057115.77577632,54.6878395080566,32,1.73789076652214,-1.38290081277818 +-152.35536,59.4963173,13.719616,92809.6583614524,1057115.77429629,59.5817184448242,32,1.77511302490021,-1.24769894605877 +-152.28975,59.4954807,13.719616,96513.7412405592,1057115.77915913,70.7227401733398,32,1.84955907919826,-0.977289627828822 +-152.22414,59.4946113,13.719616,100218.012751128,1057115.77964733,46.0614356994629,32,1.66333747046358,-1.65369966369214 +-152.15854,59.4937093,13.719616,103921.915318111,1057115.78294599,44.4888458251953,32,1.64825113898583,-1.70849752568702 +-152.09294,59.4927745,13.719616,107626.020962594,1057115.78172906,42.2245597839355,32,1.62556513048925,-1.79089958377812 +-152.02735,59.491807,13.719616,111329.772395664,1057115.77092421,57.1560211181641,32,1.75706198802357,-1.31326546427361 +-151.96176,59.4908069,13.719616,115033.74068447,1057115.77788782,82.2803268432617,32,1.91529600817999,-0.738514338579621 +-151.89617,59.489774,13.719616,118737.933712927,1057115.78081675,74.9490966796875,32,1.87476640290289,-0.885729433247105 +-151.83059,59.4887084,13.719616,122441.794156076,1057115.77301833,66.8753967285156,32,1.82526637142546,-1.06552767628877 +-151.76501,59.4876102,13.719616,126145.893044938,1057115.78357481,35.7089653015137,32,1.55277726631282,-2.05528588219172 +-151.69944,59.4864792,13.33300471,129849.674125947,1057115.7711865,19.8122959136963,32,1.29693480592084,-2.98457872304381 +-150.58547,59.4622547,9.447496389,192817.916468228,1057115.78708973,101.132209777832,33,2.00488949684643,-0.413085215215506 +-150.52,59.4605359,10.3431585,196521.70947961,1057115.77152381,16.4418392181396,33,1.21595039700037,-3.27873721149458 +-150.45453,59.4587845,12.15353749,200225.884405694,1057115.77748751,214.918975830078,33,2.3322747623247,0.776071514059573 +-150.38907,59.4570006,8.890842045,203929.883582663,1057115.78639669,42.9424438476562,33,1.6328867564335,-1.76430534854849 +-150.25817,59.4533348,13.68260971,211337.950475115,1057115.78627728,126.914840698242,33,2.103512408986,-0.0548586485429164 +-150.19273,59.451453,13.719616,215042.031873987,1057115.78818807,118.769775390625,133,2.07470593516426,-0.159491983649679 +-150.1273,59.4495387,13.719616,218745.966039768,1057115.7914742,143.674850463867,133,2.15738075379424,0.140806555357006 +-150.06188,59.4475917,13.719616,222449.761400206,1057115.77318371,147.798583984375,133,2.16967027322851,0.185445597720331 +-149.99646,59.4456122,13.719616,226153.987975107,1057115.78908528,148.045425415039,133,2.17039499228797,0.188077984199697 +-149.93106,59.4436001,13.719616,229857.525146578,1057115.75987561,164.453277587891,133,2.21604253348392,0.353882882928819 +-149.86566,59.4415554,13.719616,233561.508445437,1057115.75364596,178.212615966797,133,2.25093844521614,0.480634794625079 +-149.80026,59.4394782,13.719616,237265.944292732,1057115.78267234,198.239440917969,133,2.29719006422073,0.648633876376137 +-149.73488,59.4373685,13.719616,240969.711379982,1057115.77551807,162.610610961914,133,2.21114888155233,0.336107742325948 +-149.6695,59.4352261,13.719616,244673.946656171,1057115.78135644,93.8276519775391,33,1.97233084830958,-0.531347519864851 +-149.60414,59.4330513,13.719616,248377.526655893,1057115.76002958,93.8697509765625,33,1.97252566574432,-0.530639887335417 +-149.53878,59.4308439,13.719616,252081.588334931,1057115.76297748,97.7451400756836,33,1.99009517332332,-0.466822420971768 +-149.47343,59.428604,13.719616,255785.573848433,1057115.76404476,116.00853729248,133,2.06448995097332,-0.196599354163358 +-149.40808,59.4263315,13.719616,259490.055251641,1057115.79069703,132.704635620117,133,2.12288609384465,0.0155121046638889 +-149.34275,59.4240266,13.719616,263193.909689328,1057115.78721959,156.512359619141,133,2.19454863902269,0.275810923277343 +-149.27743,59.4216891,13.719616,266897.709995766,1057115.76940161,156.749160766602,133,2.19520522430078,0.278195828415473 +-149.21211,59.4193191,13.719616,270602.026674512,1057115.78874334,200.311401367188,133,2.3017056692633,0.665035842772753 +-149.14681,59.4169167,13.719616,274305.737581199,1057115.77507754,218.193588256836,133,2.33884198444853,0.799925539285132 +-149.08151,59.4144817,13.719616,278009.979809623,1057115.78778561,204.407043457031,133,2.31049585663792,0.696964312286612 +-149.01623,59.4120143,13.719616,281713.63038342,1057115.76565465,195.465637207031,133,2.29107041961899,0.62640558046213 +-148.95095,59.4095144,13.719616,285417.825586246,1057115.78148394,190.670272827148,133,2.28028298799358,0.587222549759112 +-148.88568,59.406982,13.719616,289122.008281223,1057115.79309773,173.654708862305,133,2.23968656423871,0.439764751308464 +-148.82043,59.4044172,13.719616,292825.620457868,1057115.76725388,129.085525512695,133,2.11087754712785,-0.0281063645920044 +-148.75518,59.4018199,13.719616,296529.798425384,1057115.78015259,106.954788208008,133,2.02920023206573,-0.324781685924342 +-148.68994,59.3991901,13.719616,300233.985039468,1057115.78799701,94.3422470092773,33,1.97470621590066,-0.522719506776636 +-148.62472,59.396528,13.719616,303937.621345268,1057115.76706551,89.8142929077148,33,1.95334545511956,-0.600307886901725 +-148.5595,59.3938333,13.719616,307641.845474301,1057115.77466946,95.3289413452148,133,1.9792247700862,-0.506306828250965 +-148.4943,59.3911063,13.719616,311345.533329145,1057115.75193972,97.8465270996094,133,1.99054541570437,-0.465187012131823 +-148.4291,59.3883469,13.719616,315049.821228107,1057115.78074196,102.727813720703,133,2.01168804544756,-0.388390946197228 +-148.36392,59.385555,13.719616,318753.588728264,1057115.75543633,132.482559204102,133,2.12215870891457,0.0128700349815216 +-148.29874,59.3827308,13.719616,322457.969354013,1057115.79358084,150.277679443359,133,2.17689448015815,0.21168597928273 +-148.23358,59.3798741,13.719616,326161.84361573,1057115.77619924,188.041351318359,133,2.27425336349047,0.565321232537634 +-148.16843,59.3769851,13.719616,329865.780788048,1057115.77344076,182.347930908203,133,2.26090083976251,0.516821055167978 +-148.10329,59.3740637,13.719616,333569.788829249,1057115.77405613,165.931915283203,133,2.21992992609864,0.368003002477812 +-148.03816,59.3711099,13.719616,337273.874736121,1057115.77795305,166.546340942383,133,2.22153509559226,0.373833436239611 +-147.97304,59.3681238,13.719616,340978.044489323,1057115.79619127,183.013565063477,133,2.2624832810631,0.522568933645446 +-147.90794,59.3651053,13.719616,344681.74187084,1057115.76567448,181.815902709961,133,2.25963186654895,0.512211782255342 +-147.84285,59.3620545,13.719616,348385.537034339,1057115.74828037,177.605133056641,133,2.24945551339055,0.475248362963657 +-147.77776,59.3589714,13.719616,352090.001132971,1057115.79699862,155.665084838867,133,2.19219121268216,0.267248077932072 +-147.71269,59.3558559,13.719616,355794.013772134,1057115.79521263,141.043182373047,133,2.14935209843662,0.111644187491747 +-147.64764,59.3527081,13.719616,359497.580863359,1057115.75238901,129.489807128906,133,2.11223558400112,-0.0231735870459636 +-147.58259,59.349528,13.719616,363201.837751467,1057115.77625842,123.904983520508,133,2.09308877426897,-0.0927202650367038 +-147.51756,59.3463156,13.719616,366905.662975925,1057115.75803952,122.359909057617,133,2.08763914552914,-0.112514872098695 +-147.45254,59.343071,13.719616,370609.626574359,1057115.76304885,124.13500213623,133,2.09389425604575,-0.0897945253160652 +-147.38753,59.339794,13.719616,374313.73767143,1057115.76910701,126.36962890625,134,2.10164271015436,-0.0616499283646046 +-147.32253,59.3364848,13.719616,378018.000986564,1057115.79855751,171.259994506836,134,2.23365592575577,0.417859751022837 +-147.25755,59.3331433,13.719616,381721.860347945,1057115.78290365,184.331680297852,134,2.26559998196981,0.533889680933617 +-147.19258,59.3297696,13.719616,385425.885737146,1057115.78975597,190.894790649414,134,2.28079407704174,0.589078971061376 +-147.12763,59.3263636,13.719616,389129.520997747,1057115.74953822,194.845596313477,230,2.28969059479194,0.621393662849087 +-147.06268,59.3229254,13.719616,392833.900283726,1057115.7901596,196.531021118164,230,2.29343111062559,0.634980284006392 +-146.99775,59.3194549,13.719616,396537.90325335,1057115.78292785,189.334060668945,140,2.27722874935704,0.576128683264708 +-146.93284,59.3159523,13.719616,400241.534443584,1057115.74859715,185.958541870117,140,2.26941613215374,0.547751027639375 +-146.86793,59.3124175,13.719616,403945.930297581,1057115.79623042,190.482116699219,140,2.27985420844514,0.585665100053312 +-146.80304,59.3088504,13.719616,407649.970496276,1057115.79384266,186.547821044922,140,2.27079018066876,0.552741964038419 +-146.73817,59.3052512,13.719616,411353.659501448,1057115.76223105,189.816436767578,140,2.27833381656537,0.580142602782941 +-146.67331,59.3016198,13.719616,415057.569578162,1057115.75136023,191.70295715332,140,2.28262881222842,0.595743252944961 +-146.60846,59.2979562,13.719616,418761.707589066,1057115.76150263,207.658737182617,140,2.31735020864778,0.72186127521327 +-146.54363,59.2942605,13.719616,422465.514940094,1057115.7404437,217.084060668945,241,2.33662793668495,0.791883485855669 +-146.47881,59.2905327,13.719616,426169.562655022,1057115.75098363,233.044708251953,341,2.36743924585231,0.903798955174704 +-146.414,59.2867727,13.719616,429873.858827893,1057115.78233325,277.031951904297,341,2.44252986197223,1.17654950591795 +-146.34921,59.2829806,13.719616,433577.844821609,1057115.7806507,297.172576904297,341,2.47300873022771,1.28725745495697 +-146.28444,59.2791564,13.719616,437281.527448792,1057115.74461425,313.740447998047,341,2.49657051235399,1.37284057284178 +-146.21967,59.2753001,13.719616,440986.041919637,1057115.80572354,537.191040039062,440,2.73012876033688,2.22119079367657 +-140.97035,58.8510373,13.719616,744713.71537106,1057115.757463,454,341,2.6570558528571,1.95576913662574 +-140.90721,58.8445622,13.719616,748417.509906915,1057115.72356802,203,341,2.30749603791321,0.686068114444982 +-140.84409,58.8380561,13.719616,752121.530546524,1057115.72500249,204,142,2.3096301674259,0.693819881976265 +-140.78099,58.8315191,13.719616,755825.781146238,1057115.77265116,197,142,2.29446622616159,0.638740119084559 +-140.71792,58.8249512,13.719616,759529.703535375,1057115.75208103,196,142,2.29225607135648,0.630712205991387 +-140.65487,58.8183525,13.719616,763233.86570786,1057115.78744598,196,142,2.29225607135648,0.630712205991387 +-140.59185,58.811723,13.719616,766937.709450814,1057115.76321828,195,142,2.29003461136252,0.622643229225523 +-140.52885,58.8050626,13.719616,770641.807198812,1057115.78278675,188,142,2.27415784926368,0.564974297603475 +-140.46588,58.7983714,13.719616,774345.598496845,1057115.74048808,190,142,2.27875360095283,0.581667379496592 +-140.40293,58.7916494,13.719616,778049.653516551,1057115.75180202,190,142,2.27875360095283,0.581667379496592 +-140.34,58.7848966,13.719616,781753.978223396,1057115.81673835,187,142,2.2718416065365,0.556561042896859 +-140.2771,58.778113,13.719616,785458.014376654,1057115.8170481,186,142,2.26951294421792,0.548102676689368 +-140.21423,58.7712988,13.719616,789161.763323333,1057115.77296954,184,142,2.26481782300954,0.531048656339518 +-140.15138,58.7644538,13.719616,792865.799778424,1057115.78038323,181,142,2.25767857486918,0.505116869349467 +-140.08856,58.7575781,13.719616,796569.563159987,1057115.73034006,181,142,2.25767857486918,0.505116869349467 +-140.02576,58.7506717,13.719616,800273.62357484,1057115.74173969,180,142,2.25527250510331,0.496377337199112 +-139.96298,58.7437346,13.719616,803977.986923527,1057115.81466519,181.393447875977,142,2.25862159582937,0.508542190641842 +-139.90024,58.7367669,13.719616,807681.528344479,1057115.71690184,180.34342956543,142,2.25610032433413,0.499384212928593 +-139.83751,58.7297686,13.719616,811385.946297631,1057115.81173471,178.851745605469,142,2.25249318325,0.486282046930483 +-139.77482,58.7227396,13.719616,815089.556409542,1057115.72182893,177.305389404297,142,2.24872193668932,0.47258380300115 +-139.71214,58.7156801,13.719616,818794.05238729,1057115.8356877,182.122970581055,142,2.2603647254075,0.51487373480834 +-139.6495,58.7085899,13.719616,822497.752232071,1057115.76173645,179.226974487305,142,2.25340337357038,0.489588117968259 +-139.58688,58.7014693,13.719616,826201.782990941,1057115.77834911,179.735977172852,142,2.25463501714107,0.494061798963094 +-139.52429,58.694318,13.719616,829905.59348199,1057115.72797733,183.118682861328,142,2.26273265587818,0.523474734152485 +-139.46172,58.6871363,13.719616,833609.746478418,1057115.76738841,219.348648071289,240,2.341134962028,0.808254288334743 +-139.39918,58.679924,13.719616,837313.688410818,1057115.74886593,244.640762329102,240,2.38852882138253,0.980402313064629 +-139.33666,58.6726813,13.719616,841017.984396094,1057115.81939205,250.557907104492,240,2.39890811275666,1.01810286188016 +-139.27418,58.6654081,13.719616,844721.514235604,1057115.71387689,249.205856323242,240,2.39655824400231,1.00956746784508 +-139.21171,58.6581044,13.719616,848425.976300491,1057115.81246,239.924087524414,240,2.38007385177688,0.94969145016832 +-139.14928,58.6507704,13.719616,852129.678795491,1057115.75391443,194.728927612305,143,2.28943047216311,0.620448823214782 +-139.08687,58.6434059,13.719616,855833.760795441,1057115.77107637,144.26301574707,143,2.15915500666052,0.14725114818951 +-139.02449,58.636011,13.719616,859537.661352489,1057115.74567532,125.07120513916,143,2.09715733456464,-0.0779420927601081 +-138.96213,58.6285858,13.719616,863241.947873129,1057115.81718218,117.219299316406,143,2.06899912103871,-0.180220761440605 +-138.8998,58.6211301,13.719616,866946.066874045,1057115.8335509,109.692314147949,143,2.04017619876823,-0.284913842008068 +-138.8375,58.6136442,13.719616,870650.016500315,1057115.82606771,104.287864685059,143,2.01823377528234,-0.364614987099997 +-138.77523,58.606128,13.719616,874353.804927741,1057115.78246695,100.997833251953,40,2.00431205678448,-0.415182642338293 +-138.71298,58.5985814,13.719616,878058.004567534,1057115.82272071,102.015815734863,40,2.00866750660424,-0.399362405423777 +-138.65076,58.5910046,13.719616,881762.051784076,1057115.83614425,101.767730712891,40,2.00761009042722,-0.40320324279533 +-138.58857,58.5833975,13.719616,885465.954765831,1057115.81051633,107.276779174805,143,2.0305057259956,-0.320039759345988 +-138.52641,58.5757602,13.719616,889169.716574981,1057115.75538589,116.270690917969,143,2.06547025319129,-0.1930386167016 +-138.46427,58.5680927,13.719616,892873.907018256,1057115.80387923,120.83097076416,143,2.08217826464981,-0.132350350142987 +-138.40216,58.560395,13.719616,896577.967495195,1057115.82135726,118.900001525879,143,2.07518186019212,-0.157763288105963 +-138.34008,58.5526671,13.719616,900281.903599884,1057115.80652409,121.706443786621,143,2.08531357269914,-0.120962016401793 +-138.27803,58.544909,13.719616,903985.720920332,1057115.75809606,121.554275512695,143,2.08477023918853,-0.122935558795187 +-138.216,58.5371208,13.719616,907689.986607847,1057115.82234062,127.555847167969,143,2.10570037148818,-0.0469113442283083 +-138.15401,58.5293025,13.719616,911393.577806722,1057115.72519344,133.788314819336,143,2.12641818345352,0.0283416622820512 +-138.09204,58.5214541,13.719616,915097.628457496,1057115.73931222,139.580902099609,143,2.14482600080761,0.0952041090262762 +-138.0301,58.5135756,13.719616,918801.579892856,1057115.72677637,142.368011474609,143,2.15341241907132,0.12639243096784 +-137.96818,58.505667,13.719616,922506.001840538,1057115.82526321,144.451034545898,143,2.15972065657112,0.149305750117364 +-137.9063,58.4977284,13.719616,926209.768738625,1057115.76714318,149.806411743164,143,2.17553040164839,0.206731256788516 +-137.84444,58.4897598,13.719616,929914.014472862,1057115.82957591,160.387313842773,143,2.20517001391094,0.314390788513696 +-137.78262,58.4817612,13.719616,933617.61612053,1057115.73186799,165.211608886719,143,2.2180405605286,0.361140287448783 +-137.72082,58.4737326,13.719616,937321.707555083,1057115.75343358,174.856307983398,143,2.24268130420584,0.450642501652979 +-137.65905,58.4656741,13.719616,941025.727319972,1057115.76390754,179.199996948242,143,2.25333799793012,0.489350654982765 +-137.59731,58.4575856,13.719616,944729.683577067,1057115.75127807,189.36474609375,143,2.27729912988351,0.576384325425449 +-137.5356,58.4494672,13.719616,948433.579037896,1057115.72522213,186.864791870117,143,2.27152748149154,0.555420051073369 +-137.47391,58.4413189,13.719616,952137.983320397,1057115.82795748,181.490768432617,143,2.25885453945072,0.5093883083633 +-137.41226,58.4331407,13.719616,955841.773434537,1057115.77216005,171.825241088867,143,2.23508696194232,0.423057682910767 +-137.35064,58.4249327,13.719616,959545.516213512,1057115.71033847,154.959991455078,143,2.19021958376286,0.26008655893826 +-137.28904,58.4166948,13.719616,963249.784008816,1057115.77558749,154.023696899414,143,2.18758754318018,0.250526236282808 +-137.22747,58.4084271,13.719616,966954.015219937,1057115.83369264,130.817245483398,143,2.11666500029239,-0.00708468279477104 +-137.16594,58.4001296,13.46493203,970657.6510024,1057115.7373917,63.4763069152832,40,1.80261165133785,-1.14781608594786 +-137.04295,58.3834454,13.55954116,978065.973032654,1057115.82852005,106.460319519043,40,2.02718776528544,-0.332091539685554 +-136.98151,58.3750586,13.719616,981769.544352483,1057115.70954578,104.713279724121,50,2.02000176233965,-0.3581931534741 +-136.92009,58.3666422,10.03088499,985473.664301876,1057115.74690796,60.7230415344238,50,1.78335351665117,-1.21776712794876 +-136.8587,58.358196,4.593511992,989177.779649593,1057115.77066082,34.8254127502441,50,1.54189627237787,-2.09480875790833 +-153.60278,59.4728693,13.719616,22433.5975826571,1053411.77345979,16.8631076812744,32,1.22693761325781,-3.23882850598382 +-153.53719,59.4726548,13.719616,26138.0030136495,1053411.77531509,20.364574432373,32,1.30887533887067,-2.94120729920262 +-153.47161,59.4724076,13.719616,29841.894656117,1053411.77524647,23.4987239837646,32,1.37104428006511,-2.71539196000193 +-153.40603,59.4721277,13.719616,33545.844487615,1053411.77676784,26.2764911651611,32,1.41956737118649,-2.53914224318001 +-153.34045,59.4718151,13.719616,37249.8597271165,1053411.78003307,28.9682159423828,32,1.4619217492515,-2.38529905290482 +-153.27487,59.4714697,13.719616,40953.9477153863,1053411.7740332,31.1000003814697,32,1.49276039435385,-2.27328429166744 +-153.2093,59.4710917,13.719616,44657.5506793252,1053411.77459524,34.7000007629395,32,1.54032948433959,-2.10049977926921 +-153.14372,59.4706809,13.719616,48361.8056087845,1053411.77245671,38.3989372253418,32,1.58431920448324,-1.94071655979129 +-153.07815,59.4702375,13.719616,52065.5899274299,1053411.77619789,40.2000007629395,32,1.60422606132677,-1.86840917375296 +-153.01257,59.4697613,13.719616,55770.0406684576,1053411.77882372,42.5370750427246,32,1.62876762340221,-1.77926721543575 +-152.947,59.4692524,13.719616,59474.0353877836,1053411.77553883,48.2971153259277,32,1.68392119212948,-1.57893371142252 +-152.88144,59.4687109,13.719616,63177.5811133221,1053411.77612945,51.1064071655273,32,1.708475350667,-1.48974599915963 +-152.81587,59.4681366,13.719616,66881.8149430364,1053411.77700189,61.7586631774902,32,1.79069788672984,-1.19109027953112 +-152.75031,59.4675296,13.719616,70585.6143981612,1053411.77006771,64.5834350585938,32,1.81012114051574,-1.12053947783216 +-152.68475,59.46689,13.719616,74289.5512301693,1053411.77635277,65.1099395751953,32,1.81364729230326,-1.10773148807596 +-152.61919,59.4662176,13.719616,77993.6330848461,1053411.77384982,55.7111740112305,32,1.7459423105188,-1.35365530684287 +-152.55363,59.4655125,13.719616,81697.8669651049,1053411.77410775,61.3377914428711,32,1.7877281345183,-1.2018772672151 +-152.48808,59.4647748,13.719616,85401.6950707187,1053411.77583282,59.618896484375,32,1.77538393319977,-1.24671492978985 +-152.42253,59.4640043,13.719616,89105.6898699592,1053411.7688171,58.8026123046875,32,1.76939662002699,-1.26846256018268 +-152.35698,59.4632012,13.719616,92809.8580538895,1053411.77584057,68.1744995117188,32,1.83362195834676,-1.03517779966867 +-152.29144,59.4623654,13.719616,96513.642329116,1053411.771633,69.4339447021484,32,1.84157183922617,-1.00630156319272 +-152.2259,59.4614969,13.719616,100217.614663535,1053411.77007076,51.9405174255371,32,1.71550627170715,-1.46420768711715 +-152.16036,59.4605957,13.719616,103921.782265882,1053411.77163077,46.7037162780762,32,1.66935143934229,-1.63185521216705 +-152.09483,59.4596619,13.719616,107625.587264971,1053411.77177869,46.8343048095703,32,1.67056407811346,-1.62745056202859 +-152.0293,59.4586954,13.719616,111329.601924738,1053411.77494039,80.4279708862305,32,1.90540711204421,-0.77443363191674 +-151.96377,59.4576962,13.719616,115033.833451196,1053411.78164651,80.1298370361328,32,1.90379425949655,-0.780291972723781 +-151.89825,59.4566643,13.719616,118737.724291063,1053411.77456638,47.9223365783691,32,1.6805379850564,-1.59122248517536 +-151.83273,59.4555998,13.719616,122441.846041862,1053411.78220558,38.9527244567871,32,1.59053783877801,-1.91812870505774 +-151.76722,59.4545026,10.69759703,126145.64149105,1053411.77497762,17.1658134460449,32,1.23466438840599,-3.21076265320442 +-150.58884,59.4291717,9.614686685,192817.699664598,1053411.77154271,28.1106433868408,33,1.44887078570552,-2.43270387761969 +-150.52343,59.4274546,13.719616,196521.735827315,1053411.77203476,207.11198425293,33,2.31620522947932,0.717702384063838 +-150.45803,59.4257049,13.71048048,200225.588577085,1053411.76081525,238.12028503418,33,2.37679639373818,0.937786787092104 +-150.32724,59.4221079,9.546513883,207633.900680055,1053411.78524909,96.3802947998047,33,1.98398825035005,-0.48900450830005 +-150.26186,59.4202605,13.71941112,211337.810136488,1053411.77876361,88.2809524536133,33,1.94586701007092,-0.627471733879111 +-150.19649,59.4183805,13.719616,215041.564710914,1053411.75891849,126.775466918945,133,2.10303521874622,-0.0565919396974374 +-150.13112,59.416468,13.719616,218745.735644385,1053411.76916757,143.563735961914,133,2.15704475146207,0.139586098981935 +-150.06576,59.414523,13.719616,222449.765277504,1053411.77705735,169.550674438477,133,2.22929952165363,0.402036047882338 +-150.00041,59.4125454,13.719616,226153.661380295,1053411.77081365,151.082611083984,133,2.17921448191116,0.220112887844098 +-149.93506,59.4105352,13.719616,229857.995839154,1053411.78445413,149.768814086914,133,2.17542139093375,0.206335298758201 +-149.86973,59.4084926,13.719616,233561.644873688,1053411.77105667,162.452606201172,133,2.21072668305378,0.334574196871787 +-149.8044,59.4064174,13.719616,237265.746470643,1053411.77752137,179.490280151367,133,2.25404093541617,0.491903924570462 +-149.73908,59.4043096,13.719616,240969.742993817,1053411.76869585,179.326034545898,133,2.25364334499349,0.490459762671655 +-149.67377,59.4021694,13.719616,244673.640107576,1053411.76637138,92.9263000488281,33,1.96813864563629,-0.546574796547999 +-149.60846,59.3999966,13.719616,248378.011100073,1053411.78512439,109.618499755859,33,2.03988385400137,-0.285975721644802 +-149.54317,59.3977914,13.719616,252081.732070967,1053411.77253586,101.612167358398,33,2.00694571483988,-0.405616444560246 +-149.47788,59.3955536,13.719616,255785.941106382,1053411.7811779,107.97306060791,33,2.03331541207265,-0.309834177549871 +-149.41261,59.3932834,13.719616,259489.51425781,1053411.75643246,131.579818725586,133,2.11918928374431,0.00208423520481831 +-149.34734,59.3909807,13.719616,263193.588868197,1053411.76429412,148.316024780273,133,2.17118807683867,0.19095869365671 +-149.28208,59.3886455,13.719616,266897.607253498,1053411.76582643,159.553421020508,133,2.20290612043427,0.306167681226896 +-149.21683,59.3862778,13.719616,270601.576485735,1053411.76062591,176.379302978516,133,2.24644762201133,0.464322842936654 +-149.15158,59.3838777,13.719616,274306.067577404,1053411.80076193,213.883148193359,133,2.33017656795187,0.768450273213182 +-149.08635,59.3814451,13.719616,278009.958872934,1053411.79266218,209.164398193359,133,2.32048776535796,0.733257776732504 +-149.02113,59.37898,13.719616,281713.822195719,1053411.77672182,200.682769775391,133,2.30251008642521,0.667957715508329 +-148.95592,59.3764825,13.719616,285417.663760042,1053411.76375562,187.659606933594,133,2.27337080232997,0.562115518494687 +-148.89071,59.3739526,13.719616,289122.055351668,1053411.79697958,180.028579711914,133,2.25534145524729,0.496627783802393 +-148.82552,59.3713902,13.719616,292825.875349267,1053411.7784321,148.488372802734,133,2.17169244809559,0.192790714023743 +-148.76034,59.3687955,13.719616,296529.693804072,1053411.77310093,110.70166015625,133,2.04415413389853,-0.270464846199095 +-148.69517,59.3661683,13.719616,300233.519487669,1053411.75842553,99.4659652709961,33,1.99767450161438,-0.439292137262966 +-148.63,59.3635087,13.719616,303937.923305625,1053411.79106891,91.4059906005859,33,1.96097465962356,-0.572596438551435 +-148.56485,59.3608167,13.719616,307641.782756284,1053411.77982364,95.0923843383789,33,1.97814573699781,-0.5102261844147 +-148.49971,59.3580923,13.719616,311345.669610374,1053411.76968243,95.2214431762695,33,1.97873475935589,-0.508086687086449 +-148.43458,59.3553355,13.719616,315049.590877683,1053411.76044677,99.3792343139648,133,1.99729564631874,-0.440668247832792 +-148.36946,59.3525463,13.719616,318753.553565364,1053411.75193535,105.287406921387,133,2.02237642976469,-0.349567683588789 +-148.30435,59.3497248,13.719616,322457.563720152,1053411.75512376,142.586349487305,133,2.15407795029772,0.128809830343662 +-148.23925,59.3468709,13.719616,326161.629279715,1053411.75872332,169.271118164062,133,2.22858286305869,0.399432939310807 +-148.17416,59.3439847,13.719616,329865.756263523,1053411.77374199,159.563034057617,133,2.20293228573478,0.306262721066663 +-148.10908,59.3410661,13.719616,333569.952625595,1053411.78892721,164.979309082031,133,2.21742948048686,0.358920670317563 +-148.04402,59.3381152,13.719616,337273.659599705,1053411.76453333,184.088745117188,133,2.26502723726601,0.531809308691803 +-147.97896,59.335132,13.719616,340978.013660432,1053411.80149261,193.647094726562,230,2.2870109856821,0.611660557725538 +-147.91392,59.3321164,13.719616,344681.893269435,1053411.78647729,191.264251708984,230,2.28163380569738,0.592129105221064 +-147.84889,59.3290685,13.719616,348385.869135859,1053411.78136146,186.315460205078,133,2.27024889356063,0.550775854762967 +-147.78387,59.3259883,13.719616,352089.948209024,1053411.78611457,166.581924438477,133,2.22162787496684,0.37417043740997 +-147.71887,59.3228759,13.719616,355793.5716211,1053411.75827926,157.587097167969,133,2.19752065567796,0.286606136067298 +-147.65387,59.3197311,13.719616,359497.87793305,1053411.78218756,147.358322143555,133,2.16837466790201,0.180739589371922 +-147.58889,59.3165541,13.719616,363201.742445992,1053411.77241348,133.600036621094,133,2.12580657718396,0.026120133741229 +-147.52392,59.3133448,13.719616,366905.737911557,1053411.77143792,129.128814697266,134,2.11102316455673,-0.0275774405269461 +-147.45896,59.3101032,13.719616,370609.871264116,1053411.779315,134.448776245117,134,2.12855685362208,0.0361099227715294 +-147.39402,59.3068294,13.719616,374313.583566312,1053411.75087785,146.909454345703,134,2.16704974567485,0.175927093672403 +-147.32908,59.3035234,13.719616,378018.011230341,1053411.79837959,175.035507202148,134,2.24312615735925,0.452258335279902 +-147.26416,59.3001851,13.719616,381722.032764043,1053411.79751434,183.247467041016,134,2.26303798026971,0.524583759490787 +-147.19926,59.2968146,13.719616,385425.653946365,1053411.75785237,190.757797241211,230,2.28048229881367,0.587946503546669 +-147.13436,59.2934119,13.719616,389130.011180029,1053411.79504358,197.127044677734,230,2.29474621103018,0.639757104042921 +-147.06948,59.289977,13.719616,392833.981831259,1053411.79260909,197.593276977539,230,2.29577216382839,0.643483657442091 +-147.00462,59.2865099,13.719616,396537.57277968,1053411.74904404,200.709899902344,140,2.3025687943456,0.668170959432071 +-146.93976,59.2830107,13.719616,400241.919231913,1053411.79451232,186.302429199219,140,2.27021851770321,0.550665520978678 +-146.87492,59.2794792,13.719616,403945.900906266,1053411.78700281,196.072616577148,241,2.29241694450996,0.631296543202596 +-146.8101,59.2759156,13.719616,407649.522288865,1053411.74729426,200.084518432617,241,2.30121348634037,0.663248093913684 +-146.74528,59.2723198,13.719616,411353.920949101,1053411.78671224,200.219955444336,241,2.30150736039334,0.664315528354061 +-146.68048,59.2686919,13.719616,415057.973003549,1053411.79329765,195.412307739258,241,2.29095191360441,0.625975132792207 +-146.6157,59.2650319,13.719616,418761.685279259,1053411.76564188,266.730438232422,341,2.42607257850237,1.11677195497904 +-146.55093,59.2613397,13.719616,422465.630609604,1053411.75485656,411.314483642578,341,2.61417400261713,1.80001001685552 +-146.48617,59.2576155,13.719616,426169.813322716,1053411.78346085,480.100830078125,341,2.68133245685031,2.04394869156171 +-146.42143,59.2538591,13.719616,429873.677990638,1053411.76482072,341.979400634766,440,2.53399994681612,1.50879496223244 +-146.3567,59.2500706,13.719616,433577.794933411,1053411.77399076,308.83544921875,440,2.48972714437253,1.34798350704143 +-146.29199,59.2462501,13.719616,437281.604907587,1053411.75657851,368.792449951172,440,2.56678202144312,1.62786881421338 +-140.9198,58.8120663,13.719616,748417.966256402,1053411.81561222,241,440,2.38201704257487,0.956749673788491 +-140.85674,58.8055662,13.719616,752121.848885714,1053411.78394012,207,341,2.31597034545692,0.716849218251904 +-140.7937,58.7990353,13.719616,755825.956262739,1053411.80554571,200,341,2.30102999566398,0.662581603403571 +-140.73069,58.7924736,13.719616,759529.729626148,1053411.76598282,196,341,2.29225607135648,0.630712205991387 +-140.6677,58.785881,13.719616,763233.741954667,1053411.76748639,195,241,2.29003461136252,0.622643229225523 +-140.60473,58.7792576,13.719616,766937.99702619,1053411.82096271,194,241,2.28780172993023,0.614532766535627 +-140.54179,58.7726034,13.719616,770641.936062895,1053411.81033314,195,142,2.29003461136252,0.622643229225523 +-140.47888,58.7659184,13.719616,774345.565039741,1053411.73390051,194,142,2.28780172993023,0.614532766535627 +-140.41598,58.7592026,13.719616,778050.019442781,1053411.82429444,192,142,2.28330122870355,0.598185661509398 +-140.35312,58.7524561,13.719616,781753.608680172,1053411.74098997,191,142,2.28103336724773,0.589948141389748 +-140.29027,58.7456788,13.719616,785458.035245101,1053411.82452698,191,142,2.28103336724773,0.589948141389748 +-140.22746,58.7388709,13.719616,789161.606212463,1053411.74199407,185,142,2.26717172840301,0.539598712600118 +-140.16466,58.7320322,13.719616,792866.026365608,1053411.82636652,184,142,2.26481782300954,0.531048656339518 +-140.1019,58.7251628,13.719616,796569.605048864,1053411.73047099,184,142,2.26481782300954,0.531048656339518 +-140.03915,58.7182628,13.719616,800274.040109513,1053411.82346426,181,142,2.25767857486918,0.505116869349467 +-139.97644,58.7113322,13.719616,803977.643140653,1053411.74390636,184.236343383789,142,2.26537530541643,0.533073591562687 +-139.91375,58.7043709,13.719616,807681.551874282,1053411.72084408,183.940490722656,142,2.26467734077586,0.530538384769195 +-139.85108,58.697379,13.719616,811385.769834745,1053411.76530396,183.003860473633,142,2.26246025128623,0.522485282922523 +-139.78844,58.6903566,13.719616,815089.735741131,1053411.76558256,184.315002441406,142,2.26556068634411,0.533746948005007 +-139.72582,58.6833035,13.719616,818794.024933854,1053411.82157408,185.318954467773,142,2.26791984133601,0.542316072305446 +-139.66323,58.67622,13.719616,822498.071342564,1053411.84232252,185.661956787109,142,2.26872292339493,0.545233095565879 +-139.60067,58.6691058,13.719616,826201.887952547,1053411.79354354,192.949172973633,142,2.28544292142124,0.605964900760014 +-139.53813,58.6619612,13.719616,829906.03813689,1053411.83143454,206.505584716797,240,2.31493180116865,0.713076928966859 +-139.47562,58.6547861,13.719616,833609.96532277,1053411.81972202,245.599166870117,240,2.39022688924305,0.986570180210875 +-139.41314,58.6475804,13.719616,837313.677730929,1053411.74600414,254.567794799805,240,2.40580346049042,1.04314873297737 +-139.35068,58.6403444,13.719616,841017.738593902,1053411.76816216,253.440765380859,240,2.40387647146315,1.0361493588129 +-139.28825,58.6330778,13.719616,844721.596232802,1053411.72648108,243.052124023438,240,2.38569942071041,0.970125122232131 +-139.22584,58.6257809,13.719616,848425.813807024,1053411.77996898,203.419677734375,143,2.30839296195004,0.689325998554348 +-139.16346,58.6184536,13.719616,852129.83473515,1053411.78963211,164.185501098633,143,2.21533480277808,0.351312202998729 +-139.10111,58.6110958,13.719616,855833.667229149,1053411.743137,140.05143737793,143,2.14628757043984,0.100512947104063 +-139.03878,58.6037077,13.719616,859537.876804606,1053411.79028066,125.70531463623,143,2.09935363940748,-0.0699644866830994 +-138.97648,58.5962893,13.719616,863241.904386388,1053411.80133238,117.098640441895,143,2.06855185278363,-0.181845367406122 +-138.91421,58.5888405,13.719616,866945.758168745,1053411.76399644,107.900001525879,143,2.03302145082453,-0.310901928707949 +-138.85196,58.5813615,13.719616,870650.003557651,1053411.82975903,102.912178039551,143,2.01246676973268,-0.385562397323629 +-138.78975,58.5738521,13.719616,874353.521746017,1053411.71382022,102.255599975586,40,2.00968710124564,-0.395658946664946 +-138.72755,58.5663125,13.719616,878058.007603808,1053411.83155484,104.748680114746,40,2.02014855934722,-0.357659944842568 +-138.66539,58.5587426,13.719616,881761.77503673,1053411.77574565,100.063430786133,40,2.00027538907251,-0.429844971647861 +-138.60325,58.5511424,13.719616,885465.959208953,1053411.81003684,100.341621398926,40,2.00148111442063,-0.425465433035212 +-138.54114,58.5435121,13.719616,889169.995847645,1053411.82262904,107.92463684082,143,2.0331205959589,-0.310541805281082 +-138.47906,58.5358516,13.719616,892873.893115542,1053411.80131536,116.877822875977,143,2.0677321132466,-0.184822895381559 +-138.41701,58.5281609,13.719616,896577.656611668,1053411.7447804,117.135841369629,143,2.06868980136957,-0.181344298767528 +-138.35498,58.52044,13.719616,900281.856687338,1053411.78728296,115.282646179199,143,2.06176393664558,-0.206501016283668 +-138.29298,58.512689,13.719616,903985.931552593,1053411.80394978,119.227195739746,143,2.07637532933509,-0.153428267528697 +-138.23101,58.5049079,13.719616,907689.886757927,1053411.79349432,122.413383483887,143,2.08782890192274,-0.111825622715269 +-138.16907,58.4970967,13.719616,911393.727847776,1053411.75464208,127.35041809082,143,2.1050003750887,-0.049453930950075 +-138.10715,58.4892555,13.719616,915098.022469907,1053411.83478042,137.325012207031,143,2.1377496462985,0.0695007696565402 +-138.04527,58.4813841,13.719616,918801.651927685,1053411.73591426,142.745635986328,143,2.15456283988792,0.130571087736541 +-137.98341,58.4734828,13.719616,922505.743286862,1053411.76551168,149.339019775391,143,2.17417329639939,0.201801863167741 +-137.92158,58.4655514,13.719616,926209.742607022,1053411.76283919,153.424468994141,143,2.18589462885469,0.244377088246765 +-137.85978,58.45759,13.719616,929913.652712791,1053411.73752856,164.59765625,143,2.21642364688513,0.355267195582595 +-137.798,58.4495987,13.719616,933618.041140655,1053411.8397948,170.722808837891,143,2.23229154742225,0.412903939483148 +-137.73626,58.4415774,13.719616,937321.78652457,1053411.776984,172.617050170898,143,2.23708369073853,0.430310371821761 +-137.67454,58.4335261,13.719616,941026.023846386,1053411.82962996,184.137603759766,143,2.2651424872423,0.532227929501323 +-137.61286,58.425445,13.719616,944729.623589434,1053411.73539318,191.518692016602,143,2.28221116704358,0.594226246425813 +-137.5512,58.4173339,13.719616,948433.726142074,1053411.7553786,194.895980834961,143,2.28980288314432,0.621801526195215 +-137.48957,58.409193,13.719616,952137.766693391,1053411.768399,195.480804443359,143,2.29110411757014,0.626527981039056 +-137.42797,58.4010222,13.719616,955841.753383246,1053411.76246929,188.980972290039,143,2.27641807906509,0.573184097376019 +-137.3664,58.3928216,13.719616,959545.688846075,1053411.74727827,186.30793762207,143,2.27023135834245,0.550712161845479 +-137.30486,58.3845912,13.719616,963249.578449699,1053411.72169232,160.469711303711,143,2.20539307128909,0.315200996578041 +-137.24334,58.376331,13.719616,966953.992314041,1053411.83019059,168.511215209961,143,2.22662881049942,0.39233526267338 +-137.18186,58.368041,13.719616,970657.806277828,1053411.78101732,179.05078125,143,2.25297622030365,0.488036575381839 +-137.12041,58.3597212,13.719616,974361.590448487,1053411.71811667,146.119674682617,143,2.16470869663801,0.167423735368681 +-137.05898,58.3513718,13.719616,978065.909287858,1053411.80930029,164.208282470703,143,2.21539505863364,0.351531069464886 +-136.99759,58.3429926,13.719616,981769.644215263,1053411.73786391,158.510177612305,150,2.20005715260398,0.295819416890903 +-136.93622,58.3345837,13.37826997,985473.927238017,1053411.80865598,115.338981628418,50,2.06197611254123,-0.205730332869647 +-136.87489,58.3261452,11.04750841,989177.631283974,1053411.73519617,101.350883483887,50,2.00582753882582,-0.409677979002527 +-153.60317,59.4397434,13.719616,22433.7041815373,1049707.7799054,18.5135459899902,32,1.26748960926582,-3.09153208179072 +-153.53765,59.4395291,13.719616,26137.8103008461,1049707.7788181,22.3484916687012,32,1.34924821730845,-2.79456148114982 +-153.47213,59.4392821,13.719616,29841.9673195966,1049707.77615123,24.8472919464111,32,1.39527906281511,-2.62736431175829 +-153.40662,59.4390025,13.719616,33545.6170373432,1049707.77816997,26.8999996185303,32,1.42975227384366,-2.50214776966852 +-153.3411,59.4386901,13.719616,37249.8974902476,1049707.77221081,30.2213916778564,32,1.48031445947678,-2.31849147956447 +-153.27559,59.4383451,13.719616,40953.6850503179,1049707.77014659,34.7000007629395,32,1.54032948433959,-2.10049977926921 +-153.21008,59.4379675,13.719616,44657.5522151695,1049707.77721758,37.4957656860352,32,1.57398222658054,-1.97826341400115 +-153.14456,59.4375571,13.719616,48362.071770101,1049707.77855219,40.2000007629395,32,1.60422606132677,-1.86840917375296 +-153.07906,59.4371141,13.719616,52065.5547038174,1049707.77488993,43.9000015258789,32,1.64246453533736,-1.72951612179941 +-153.01355,59.4366384,13.719616,55769.7043109604,1049707.77714005,46.8636016845703,32,1.67083566308351,-1.62646408789932 +-152.94804,59.43613,13.719616,59473.962488493,1049707.7782815,49.9138107299805,32,1.69822072786703,-1.52699371612988 +-152.88254,59.435589,13.719616,63177.7709447498,1049707.78025981,54.4980163574219,32,1.73638069492428,-1.38838582383897 +-152.81704,59.4350152,13.719616,66881.7025730425,1049707.76941009,67.9507064819336,32,1.83219397644173,-1.04036463753432 +-152.75154,59.4344089,13.719616,70585.7639873554,1049707.77958564,66.4201736450195,32,1.82230000665796,-1.07630235980913 +-152.68604,59.4337698,13.719616,74289.962996042,1049707.77758078,63.7328643798828,32,1.80436343764544,-1.14145309806908 +-152.62055,59.4330981,13.719616,77993.7410619075,1049707.77436043,53.8954010009766,32,1.73155170757796,-1.40592608421102 +-152.55506,59.4323937,13.719616,81697.670920812,1049707.76974254,59.0311279296875,32,1.77108108152645,-1.26234411522347 +-152.48957,59.4316567,13.719616,85401.7595274079,1049707.77529192,60.8841285705566,32,1.78450409439683,-1.21358790116894 +-152.42408,59.430887,13.719616,89106.0143221442,1049707.78023411,64.6511688232422,32,1.81057638086213,-1.11888591495551 +-152.3586,59.4300847,13.719616,92809.876920117,1049707.78219414,74.3194580078125,32,1.87110253380213,-0.899037651593445 +-152.29312,59.4292497,13.719616,96513.9200983633,1049707.7832934,71.403694152832,32,1.85372068108553,-0.962173501934825 +-152.22765,59.428382,13.719616,100217.58574671,1049707.76889936,67.4296798706055,32,1.82885109782347,-1.05250692682843 +-152.16217,59.4274817,13.719616,103922.011392944,1049707.78028825,61.2066535949707,32,1.78679863558533,-1.20525347264505 +-152.09671,59.4265488,13.719616,107625.508259998,1049707.7710081,75.7040023803711,32,1.87911884073865,-0.869920136718203 +-152.03124,59.4255832,13.719616,111329.779797689,1049707.7773381,83.5589447021484,32,1.92199294647189,-0.714189147206943 +-151.96578,59.424585,13.719616,115033.70223379,1049707.77801399,53.0737266540527,32,1.72487958336084,-1.43016114378145 +-151.90032,59.4235541,11.61155452,118737.848406126,1049707.77861249,27.8970966339111,32,1.44555900680466,-2.44473320386343 +-150.72291,59.3994214,9.890825715,185409.674964427,1049707.77548602,102.54712677002,33,2.01092349653855,-0.39116800605875 +-150.5922,59.3960882,12.63739183,192817.672912631,1049707.77235805,216.324295043945,33,2.33510529711365,0.786352824328099 +-150.52685,59.3943728,13.719616,196521.945563327,1049707.78914881,250.093566894531,33,2.3981025206064,1.01517672125152 +-150.46151,59.3926248,13.48275583,200226.033674596,1049707.79113047,166.066802978516,33,2.22028282496091,0.369284831872926 +-150.33086,59.3890312,13.71844476,207633.683591434,1049707.77013562,162.655792236328,33,2.21126953328947,0.336545983872674 +-150.26554,59.3871856,13.719616,211337.824938502,1049707.77759396,107.119621276855,33,2.02986902855154,-0.322352426194353 +-150.20023,59.3853075,13.719616,215041.8096015,1049707.77974813,129.385833740234,133,2.11188672868788,-0.0244407291168759 +-150.13493,59.3833968,13.719616,218745.645328051,1049707.76478541,148.820999145508,133,2.1726642159516,0.196320452246915 +-150.06963,59.3814537,13.719616,222449.903239884,1049707.7878934,168.003479003906,133,2.22531827515774,0.387575024248379 +-150.00434,59.379478,13.719616,226154.02642616,1049707.79375261,172.475173950195,133,2.23672659162746,0.429013285924104 +-149.93906,59.3774698,13.719616,229858.021328148,1049707.79292706,162.323608398438,133,2.21038168835077,0.333321077639141 +-149.87379,59.3754291,13.719616,233561.895035526,1049707.7848362,169.505584716797,133,2.22918401151687,0.401616482095767 +-149.80853,59.3733559,13.719616,237265.654636006,1049707.76891698,190.696716308594,133,2.28034321480093,0.587441310713855 +-149.74327,59.3712502,13.719616,240969.872531349,1049707.78090841,188.52082824707,133,2.27535933912039,0.569338451702397 +-149.67802,59.369112,13.719616,244673.99048917,1049707.78511327,126.405212402344,33,2.10176498273515,-0.061205799451117 +-149.61278,59.3669414,13.719616,248378.014852986,1049707.79217743,95.4990463256836,33,1.97999903464593,-0.503494478372917 +-149.54755,59.3647383,13.719616,252081.953418477,1049707.79044967,109.422134399414,133,2.03910518191693,-0.288804080910619 +-149.48233,59.3625027,13.719616,255785.813263035,1049707.77945418,126.024444580078,133,2.10045479207457,-0.0659647858959747 +-149.41712,59.3602346,13.719616,259489.601461885,1049707.75873259,123.890640258789,133,2.09303849735666,-0.0929028851326759 +-149.35191,59.3579341,13.719616,263193.889622216,1049707.77862846,146.249816894531,133,2.16509533101579,0.168828101785241 +-149.28672,59.3556012,13.719616,266897.554149879,1049707.76001156,158.720413208008,133,2.20063278544093,0.29791027965667 +-149.22153,59.3532358,13.719616,270601.733516527,1049707.77114112,173.80485534668,133,2.24006190456844,0.441128094518861 +-149.15635,59.350838,13.719616,274305.868657643,1049707.7831484,200.705993652344,133,2.30256034195073,0.668140257921344 +-149.09118,59.3484077,13.719616,278009.967430065,1049707.78450914,206.557907104492,133,2.31504182456615,0.713476565350398 +-149.02602,59.3459451,13.719616,281714.035222183,1049707.7971681,199.559783935547,133,2.30007302505442,0.65910561300305 +-148.96088,59.34345,13.719616,285417.515406692,1049707.75550867,194.868759155273,133,2.28974221975391,0.621581179446179 +-148.89574,59.3409225,13.719616,289121.544814089,1049707.75575621,178.626007080078,133,2.25194469032576,0.484289764074164 +-148.83061,59.3383626,13.719616,292825.56514994,1049707.75518619,153.496994018555,133,2.18609987496671,0.245122600708689 +-148.76549,59.3357704,13.719616,296529.582553064,1049707.76465703,125.341766357422,133,2.09809581062784,-0.0745332798308253 +-148.70038,59.3331457,13.719616,300233.605789937,1049707.76160533,104.725967407227,133,2.02005438085164,-0.358002028019754 +-148.63528,59.3304887,13.719616,303937.640103093,1049707.76806916,91.7259368896484,33,1.96249215633888,-0.567084457344704 +-148.57019,59.3277993,13.719616,307641.693384522,1049707.77266641,101.422080993652,133,2.00613251722337,-0.408570210413099 +-148.50511,59.3250775,13.719616,311345.772643276,1049707.77517826,98.0733489990234,133,1.99155100579827,-0.461534421886793 +-148.44004,59.3223234,13.719616,315049.883950835,1049707.78654459,100.841285705566,133,2.00363837420466,-0.417629649756362 +-148.37498,59.3195369,13.719616,318754.035224138,1049707.79543747,103.217864990234,133,2.01375487166331,-0.380883643450681 +-148.30994,59.3167181,13.719616,322457.667191482,1049707.76427433,118.334785461426,133,2.07311242774964,-0.165280057411878 +-148.2449,59.313867,13.719616,326161.917450705,1049707.78945394,150.33837890625,133,2.17706986295234,0.212323019650468 +-148.17988,59.3109835,13.719616,329865.663311282,1049707.76203507,185.000869750977,133,2.26717377017146,0.539606128885879 +-148.11486,59.3080678,13.719616,333570.040419301,1049707.80295801,190.517608642578,133,2.27993512165411,0.585958999923231 +-148.04986,59.3051197,13.719616,337273.927068211,1049707.78994784,194.224456787109,230,2.28830391547379,0.616356847767891 +-147.98487,59.3021393,13.719616,340977.894550139,1049707.78372764,206.050094604492,230,2.31397281825978,0.709593629320872 +-147.91989,59.2991267,13.719616,344681.948794734,1049707.79536313,192.14274597168,230,2.28362399304737,0.599358033732258 +-147.85493,59.2960817,13.719616,348385.533468375,1049707.75007572,183.255615234375,133,2.26305729096905,0.524653901462604 +-147.78997,59.2930045,13.719616,352089.784093998,1049707.77445808,178.669921875,133,2.25205144750746,0.48467753662964 +-147.72503,59.289895,13.719616,355793.57800481,1049707.75188354,177.674957275391,133,2.24962621968185,0.475868416938087 +-147.66009,59.2867533,13.719616,359498.051707404,1049707.80007265,176.038223266602,134,2.24560697662912,0.461269378964386 +-147.59518,59.2835793,13.719616,363201.517234766,1049707.74551371,161.787582397461,134,2.20894518536516,0.328103288776637 +-147.53027,59.2803731,13.719616,366905.676381798,1049707.76176438,153.237426757812,134,2.18536485047454,0.242452781956242 +-147.46537,59.2771347,13.719616,370609.970730972,1049707.79473958,149.665145874023,134,2.17512067330899,0.205243006511715 +-147.40049,59.273864,13.719616,374313.842970918,1049707.77701481,164.631912231445,134,2.21651402263015,0.355595466084325 +-147.33562,59.2705612,13.719616,378017.863102515,1049707.7861702,181.984832763672,134,2.26003519391074,0.513676782354439 +-147.27076,59.2672261,13.719616,381722.04024432,1049707.80005382,194.068634033203,134,2.28795534905626,0.615090755048664 +-147.20592,59.2638589,13.719616,385425.813715371,1049707.78299075,192.384506225586,134,2.28417009300491,0.6013416246505 +-147.14109,59.2604594,13.719616,389129.7579874,1049707.76978796,199.886581420898,230,2.300783640489,0.66168677109126 +-147.07627,59.2570278,13.719616,392833.877645687,1049707.78283589,201.420669555664,230,2.30410403530084,0.673747392782907 +-147.01147,59.2535641,13.719616,396537.614218113,1049707.76258591,237.716445922852,230,2.37605922853707,0.935109192673784 +-146.94668,59.2500681,13.719616,400241.542231832,1049707.74557509,345.408660888672,241,2.53833322300851,1.52453465820339 +-146.8819,59.2465401,13.719616,403945.665001193,1049707.7653531,358.771331787109,241,2.55481773274416,1.58441110271078 +-146.81713,59.2429799,13.719616,407649.99174153,1049707.79989733,311.674987792969,241,2.49370195114,1.36242113974369 +-146.75238,59.2393876,13.719616,411353.962782347,1049707.79861194,196.591812133789,341,2.29356542591136,0.635468155461711 +-140.80639,58.7665497,13.719616,755825.897534356,1049707.80160542,212,440,2.32633586092875,0.754499729058273 +-140.74344,58.759994,13.719616,759529.52008812,1049707.72121485,208,440,2.31806333496276,0.724451553535809 +-140.6805,58.7534075,13.719616,763233.941690216,1049707.80385883,201,440,2.30319605742049,0.670449357958785 +-140.61759,58.7467903,13.719616,766938.035455736,1049707.83113705,203,440,2.30749603791321,0.686068114444982 +-140.55471,58.7401422,13.719616,770641.811827333,1049707.77942779,202,341,2.30535136944662,0.678278066425006 +-140.49185,58.7334634,13.719616,774345.8376098,1049707.78552601,200,341,2.30102999566398,0.662581603403571 +-140.42902,58.7267538,13.719616,778049.555691916,1049707.72130673,200,341,2.30102999566398,0.662581603403571 +-140.36621,58.7200136,13.719616,781753.532794935,1049707.72469192,198,241,2.29666519026153,0.646727384342376 +-140.30342,58.7132426,13.719616,785457.779391075,1049707.77379765,198,241,2.29666519026153,0.646727384342376 +-140.24066,58.7064409,13.719616,789161.733816114,1049707.76075482,195,142,2.29003461136252,0.622643229225523 +-140.17792,58.6996086,13.719616,792865.964991017,1049707.81424305,195,142,2.29003461136252,0.622643229225523 +-140.11521,58.6927456,13.719616,796569.915797326,1049707.80341963,193,142,2.28555730900777,0.60638038912377 +-140.05253,58.685852,13.719616,800273.589808068,1049707.73759853,189.374084472656,142,2.27732054625861,0.576462115812646 +-139.98987,58.6789277,13.719616,803977.560546249,1049707.72530084,186.777816772461,142,2.27132529467032,0.554685650828825 +-139.92723,58.6719729,13.719616,807681.829202242,1049707.78846231,186.813262939453,142,2.2714077060319,0.554984992416606 +-139.86462,58.6649874,13.719616,811385.841006294,1049707.78313961,188.696426391602,142,2.2757636754002,0.570807116479742 +-139.80204,58.6579714,13.719616,815089.597096208,1049707.72961236,188.356994628906,142,2.27498175234568,0.567966948762633 +-139.73948,58.6509249,13.719616,818793.668600987,1049707.749607,187.482040405273,142,2.27295967138929,0.560622173569683 +-139.67694,58.6438478,13.719616,822498.063719671,1049707.83232682,189.909942626953,142,2.27854770257264,0.58091949781051 +-139.61444,58.6367402,13.719616,826201.65525036,1049707.74001315,200.110916137695,240,2.30127078023569,0.663456201694774 +-139.55196,58.6296022,13.719616,829905.577208552,1049707.73030922,247.224349975586,240,2.39309124367902,0.996974333090475 +-139.4895,58.6224336,13.719616,833609.84019865,1049707.78154629,256,240,2.40823996531185,1.05199881393653 +-139.42707,58.6152346,13.719616,837313.879853836,1049707.78963977,254.6259765625,240,2.40590270765335,1.04350922700111 +-139.36467,58.6080052,13.719616,841017.701921748,1049707.75309454,242.465667724609,240,2.38465025273899,0.966314244697603 +-139.30229,58.6007454,13.719616,844721.877460295,1049707.79762414,183.457138061523,143,2.26353461421364,0.52638767572858 +-139.23994,58.5934551,13.719616,848425.849352967,1049707.78477717,171.704452514648,143,2.23478155711473,0.421948365405777 +-139.17762,58.5861345,13.719616,852129.61841311,1049707.73490137,153.287948608398,143,2.18550801226724,0.242972786449795 +-139.11532,58.5787835,13.719616,855833.75813442,1049707.76451788,135.91096496582,143,2.1332544959676,0.0531731006110561 +-139.05305,58.5714022,13.719616,859537.706425115,1049707.75533524,125.367980957031,143,2.09818663163595,-0.0742033920064697 +-138.9908,58.5639906,13.719616,863242.034283207,1049707.83591166,113.879119873047,143,2.05644410199655,-0.225824174160922 +-138.92859,58.5565486,13.719616,866945.619267191,1049707.73453226,106.099998474121,143,2.02571537765553,-0.337439671818666 +-138.8664,58.5490764,13.719616,870649.592660438,1049707.73210353,101.125160217285,40,2.00485922269378,-0.413195179579024 +-138.80423,58.5415739,13.719616,874353.962631538,1049707.81801787,100.903015136719,40,2.00390414381545,-0.416664298671769 +-138.7421,58.5340411,13.719616,878057.604206667,1049707.72814053,97.0263290405273,40,1.98688960030166,-0.478465977148074 +-138.67999,58.5264782,13.719616,881761.648559784,1049707.74673979,87.4417953491211,40,1.94171906593858,-0.642538250908887 +-138.61791,58.518885,13.719616,885465.541091025,1049707.71903675,96.2237396240234,40,1.9832822312458,-0.491568971204588 +-138.55585,58.5112616,13.719616,889169.850181272,1049707.78845513,102.400001525879,143,2.0102999631113,-0.393432857440652 +-138.49382,58.5036081,13.719616,892874.013532688,1049707.83175883,117.819488525391,143,2.07121713305723,-0.172164308705691 +-138.43182,58.4959244,13.719616,896578.039308603,1049707.83674794,116.994995117188,143,2.06816728363096,-0.183242232335596 +-138.36985,58.4882106,13.719616,900281.930494961,1049707.81297908,118.903076171875,143,2.07519309050758,-0.15772249639476 +-138.30791,58.4804666,13.719616,903985.695263327,1049707.74828152,120.865646362305,143,2.08230287889732,-0.13189771562759 +-138.24599,58.4726926,13.719616,907689.899257181,1049707.79977086,125.417610168457,143,2.09835852104035,-0.0735790406275851 +-138.1841,58.4648885,13.719616,911393.985309834,1049707.81973586,127.66918182373,143,2.10608607518688,-0.0455103583038473 +-138.12224,58.4570544,13.719616,915097.95631224,1049707.81776379,132.613235473633,143,2.12258687102434,0.0144252419738294 +-138.06041,58.4491902,13.719616,918801.82042187,1049707.78173436,148.806838989258,143,2.17262289133784,0.196170349454536 +-137.99861,58.441296,13.719616,922505.580497318,1049707.72125365,153.849456787109,143,2.18709596717576,0.248740691924981 +-137.93683,58.4333718,13.719616,926209.807343466,1049707.77454599,164.154403686523,143,2.21525253781835,0.351013393184265 +-137.87508,58.4254177,13.719616,929913.938440233,1049707.81287764,167.228775024414,143,2.22331100850428,0.380284058832069 +-137.81336,58.4174336,13.719616,933617.981930808,1049707.82417814,176.815460205078,143,2.24752023572348,0.468218882093604 +-137.75167,58.4094196,13.719616,937321.940578804,1049707.81808286,179.30973815918,143,2.25360387636615,0.49031640135169 +-137.69001,58.4013756,13.719616,941025.822535277,1049707.78254983,183.868087768555,143,2.26450635942478,0.529917331699111 +-137.62838,58.3933018,13.719616,944729.627804487,1049707.7380694,191.910186767578,143,2.28309802809414,0.597447578896805 +-137.56677,58.3851981,13.719616,948433.929831207,1049707.81543288,195.375534057617,143,2.29087017816971,0.625678246363751 +-137.5052,58.3770645,13.719616,952137.603398992,1049707.72840495,199.997543334961,143,2.30102466105087,0.662562226566086 +-137.44365,58.3689011,13.719616,955841.781792429,1049707.7728413,200.830169677734,143,2.30282895518787,0.669115937868499 +-137.38213,58.3607079,13.719616,959545.905068686,1049707.80477667,197.47639465332,143,2.29551518966122,0.642550253919191 +-137.32064,58.3524849,13.719616,963249.978594805,1049707.82306985,191.848388671875,143,2.28295815592499,0.596939523254966 +-137.25918,58.3442321,13.719616,966954.00773162,1049707.82659101,187.38410949707,143,2.27273275917532,0.559797963641359 +-137.19775,58.3359496,13.719616,970657.995036699,1049707.82504011,183.801773071289,143,2.26434969655696,0.529348287447178 +-137.13635,58.3276374,13.719616,974361.945828455,1049707.81730204,161.457443237305,143,2.20805807092256,0.324881035913458 +-137.07498,58.3192954,13.719616,978065.868236054,1049707.79145991,147.23583984375,143,2.168013537935,0.17942786225496 +-137.01364,58.3109238,13.719616,981769.761941435,1049707.76804988,178.594833374023,143,2.25186889089291,0.484014438898739 +-136.95233,58.3025225,13.719616,985473.635051298,1049707.7351748,142.311157226562,150,2.15323895020361,0.125762342527369 +-136.89104,58.2940915,13.719616,989178.058175114,1049707.8407121,67.1034774780273,50,1.82674502703017,-1.06015677708213 +-136.82979,58.285631,13.69559991,992881.900254236,1049707.80786949,47.5307083129883,50,1.67697428629413,-1.60416685626083 +-136.76857,58.2771408,12.02690275,996585.737559415,1049707.76237345,31.1889114379883,50,1.4940002171834,-2.26878090126984 +-153.79992,59.4070633,12.82694347,11322.0372009518,1046003.78030633,11.487922668457,32,1.0602415034324,-3.84431635667642 +-153.73447,59.4069471,13.719616,15025.7270567537,1046003.77115363,15.6421165466309,32,1.19429551741504,-3.35739391506649 +-153.66901,59.4067984,13.719616,18730.0119114793,1046003.78115022,15.6565523147583,32,1.19469613348674,-3.35593876314687 +-153.60356,59.4066169,13.719616,22433.7673640394,1046003.77175171,24.0938682556152,32,1.38190653130605,-2.67593716309969 +-153.53811,59.4064029,13.23761236,26137.5663002263,1046003.77886294,11.1405277252197,32,1.04690576379305,-3.89275556944558 +-153.34175,59.4055647,13.71801122,37249.8626722219,1046003.77195531,34.9253883361816,32,1.54314124374322,-2.09028666655919 +-153.2763,59.4052201,13.719616,40953.907862939,1046003.77992899,43.9000015258789,32,1.64246453533736,-1.72951612179941 +-153.21085,59.4048428,13.719616,44658.0326622267,1046003.7828159,42.0999984741211,32,1.62428208009503,-1.79555998902895 +-153.14541,59.4044328,13.719616,48361.6784068604,1046003.77354071,43.9000015258789,32,1.64246453533736,-1.72951612179941 +-153.07996,59.4039902,13.719616,52065.9838997261,1046003.77751489,45.7000007629395,32,1.65991620732019,-1.66612666795467 +-153.01452,59.403515,13.719616,55769.8245699373,1046003.77985851,49.4573440551758,32,1.69423079028746,-1.54148630826043 +-152.94908,59.4030071,13.719616,59473.773644478,1046003.77693413,54.6181907653809,32,1.73733730998121,-1.38491112490708 +-152.88364,59.4024666,13.719616,63177.838144226,1046003.78019967,61.1420974731445,32,1.78634033307159,-1.20691815818753 +-152.8182,59.4018934,13.719616,66882.0254434024,1046003.77877158,74.3431777954102,32,1.87124112105234,-0.898534263143918 +-152.75277,59.4012876,13.719616,70585.7766659844,1046003.77351452,69.7209548950195,32,1.84336332655611,-0.999794369868982 +-152.68734,59.4006492,13.719616,74289.6648599006,1046003.7742731,62.0272064208984,32,1.79258222186609,-1.18424583647344 +-152.62191,59.3999781,13.719616,77993.6974306694,1046003.77021789,64.8484497070312,32,1.81189959812666,-1.11407961216694 +-152.55648,59.3992744,13.719616,81697.881341189,1046003.77289513,57.2046890258789,32,1.75743162904828,-1.3119228225658 +-152.49106,59.3985381,13.719616,85401.6578898523,1046003.7698302,60.0816268920898,32,1.7787416839943,-1.23451862050661 +-152.42564,59.3977692,13.719616,89105.600121946,1046003.77316991,67.4165191650391,32,1.82876632536618,-1.05281484458974 +-152.36022,59.3969676,13.719616,92809.7154842635,1046003.77215717,77.7768173217773,32,1.89085016756086,-0.827308609245885 +-152.2948,59.3961334,13.719616,96514.010892749,1046003.77840859,83.4351348876953,32,1.92134897239561,-0.716528244860512 +-152.22939,59.3952666,13.719616,100217.927642775,1046003.77728981,81.6388244628906,32,1.91189674257814,-0.750861441492544 +-152.16398,59.3943672,13.719616,103922.038776466,1046003.78324991,57.9011535644531,32,1.76268721626087,-1.29283302971573 +-152.09858,59.3934352,13.719616,107625.78558749,1046003.78057464,61.0090713500977,32,1.78539441442694,-1.21035400469693 +-152.03318,59.3924705,13.719616,111329.741447296,1046003.773688,53.6029624938965,32,1.72918879266288,-1.41450886562564 +-151.96778,59.3914732,13.719616,115033.913212433,1046003.77429413,41.3615989685059,32,1.61659731949053,-1.82347323299355 +-151.90239,59.3904434,9.436432752,118737.741820671,1046003.77623447,12.5973291397095,32,1.10027847663808,-3.69889064230351 +-150.72613,59.366334,9.262298688,185409.943857389,1046003.77936964,13.7335195541382,33,1.13778185020568,-3.56266768497745 +-150.59555,59.3630041,11.79515933,192817.83839846,1046003.77953931,63.3510704040527,33,1.80175395728807,-1.15093147554692 +-150.53027,59.3612903,13.719616,196521.775593692,1046003.77211337,285.022705078125,33,2.45487945754316,1.22140676195709 +-150.465,59.359544,13.43739781,200225.526550674,1046003.75682581,82.5219955444336,33,1.9165697215243,-0.733887848159118 +-150.39973,59.3577652,8.43869727,203929.664244004,1046003.76366083,63.2605361938477,33,1.80113286865846,-1.15318744672597 +-150.33447,59.3559539,13.719616,207633.629898961,1046003.76232133,84.2365264892578,133,1.92550045032309,-0.701448892078137 +-150.26921,59.3541101,13.719616,211337.996486673,1046003.78394208,143.123519897461,133,2.15571100847915,0.13474156377982 +-150.20397,59.3522338,13.719616,215041.639355091,1046003.76476512,148.607833862305,133,2.17204170386262,0.194059310657104 +-150.13873,59.350325,13.719616,218745.69734555,1046003.76834066,154.843490600586,133,2.18989295295618,0.258900142618688 +-150.0735,59.3483837,13.719616,222449.611676144,1046003.76221073,167.47135925293,133,2.22394054521191,0.382570715841858 +-150.00827,59.34641,13.719616,226153.954639056,1046003.79097169,179.523864746094,133,2.25412218906268,0.492199061006654 +-149.94306,59.3444037,13.719616,229857.602907112,1046003.76415174,177.940536499023,133,2.25027489565236,0.478224593213505 +-149.87785,59.342365,13.719616,233561.693959858,1046003.77215354,184.748550415039,133,2.26658103949328,0.537453161880567 +-149.81265,59.3402938,13.719616,237265.669679341,1046003.76919736,183.056777954102,133,2.26258581392538,0.522941362267039 +-149.74746,59.3381901,13.719616,240969.537147772,1046003.7547352,172.294723510742,133,2.23627197747555,0.427361997564601 +-149.68227,59.336054,13.719616,244673.868592722,1046003.77623595,151.224761962891,133,2.17962290957361,0.22159641369096 +-149.6171,59.3338855,13.719616,248377.539311866,1046003.76005736,107.52458190918,133,2.03150776255011,-0.316400076570299 +-149.55193,59.3316845,13.719616,252081.688844292,1046003.76878816,120.392524719238,133,2.08059952202171,-0.13808479398626 +-149.48677,59.3294511,13.719616,255785.757630866,1046003.7762626,134.40299987793,133,2.12840896228843,0.0355727392353036 +-149.42162,59.3271852,13.719616,259489.753480706,1046003.77086323,137.997497558594,133,2.13987121099292,0.0772068981815123 +-149.35648,59.3248869,13.719616,263193.682682254,1046003.7632998,137.460800170898,133,2.13817886764517,0.0710598240995953 +-149.29135,59.3225563,13.719616,266897.551477987,1046003.76429633,165.141326904297,133,2.2178557698136,0.360469074827383 +-149.22622,59.3201931,13.719616,270601.935150207,1046003.78073016,179.034027099609,133,2.25293558057307,0.487888960280621 +-149.16111,59.3177976,13.719616,274305.706605158,1046003.76472985,193.516738891602,133,2.28671853676497,0.610598299785292 +-149.096,59.3153697,13.719616,278010.005410246,1046003.78681678,190.135467529297,133,2.27906313693653,0.582791702539771 +-149.03091,59.3129095,13.719616,281713.706007488,1046003.7746146,190.939193725586,133,2.28089508434773,0.589445858427074 +-148.96582,59.3104168,13.719616,285417.948828195,1046003.7897632,186.525924682617,133,2.2707392016361,0.55255679364094 +-148.90075,59.3078917,13.719616,289121.60832057,1046003.75769057,161.793960571289,133,2.20896230627801,0.328165476818903 +-148.83568,59.3053343,13.719616,292825.822381886,1046003.77574842,146.659378051758,133,2.16630983892182,0.173239541154978 +-148.77062,59.3027445,13.719616,296530.033000856,1046003.78952016,144.520904541016,133,2.1599306711076,0.150068582857972 +-148.70558,59.3001224,13.719616,300233.680426607,1046003.76466901,115.403251647949,133,2.06221804584628,-0.20485156205105 +-148.64054,59.2974679,13.719616,303937.904286097,1046003.77965101,103.4931640625,133,2.01491166469167,-0.376681840990069 +-148.57552,59.2947811,13.719616,307641.578927775,1046003.75439577,100.534317016602,133,2.00231433187587,-0.42243894941382 +-148.5105,59.292062,13.719616,311345.843072208,1046003.78076865,101.536842346191,133,2.00662365332752,-0.406786263898648 +-148.4455,59.2893105,13.719616,315049.572876201,1046003.75421512,104.139404296875,133,2.01761508907503,-0.366862231995576 +-148.3805,59.2865267,13.719616,318753.906142883,1046003.78000894,102.487167358398,133,2.01066948983729,-0.392090630898427 +-148.31552,59.2837107,13.719616,322457.717133922,1046003.77367979,109.572708129883,133,2.03970239552992,-0.286634830606488 +-148.25055,59.2808623,13.719616,326161.580586298,1046003.76023051,128.791519165039,133,2.10988726596564,-0.0317033484275233 +-148.18558,59.2779816,13.719616,329866.068388584,1046003.80033256,163.777252197266,133,2.21425358038375,0.347384894650934 +-148.12063,59.2750686,13.719616,333570.055750145,1046003.79508066,182.195114135742,133,2.26053672646608,0.515498491747086 +-148.0557,59.2721234,13.719616,337273.548625777,1046003.75383189,193.839370727539,133,2.28744199125532,0.613226092988734 +-147.99077,59.2691459,13.719616,340977.686692092,1046003.76637402,196.316680908203,230,2.29295720290413,0.633258915895341 +-147.92585,59.2661361,13.719616,344681.91102386,1046003.78240752,199.542373657227,230,2.30003513406504,0.658967982114452 +-147.86095,59.2630941,13.719616,348385.661660938,1046003.76055152,186.514343261719,230,2.27071223539346,0.552458844550731 +-147.79606,59.2600199,13.719616,352089.511387307,1046003.75210888,190.669616699219,133,2.2802814935119,0.587217121375085 +-147.73117,59.2569134,13.719616,355794.034037843,1046003.79949963,193.70051574707,134,2.28713077707331,0.612095674250298 +-147.66631,59.2537747,13.719616,359497.537863431,1046003.75312606,192.980133056641,134,2.28551260150528,0.606217998713916 +-147.60145,59.2506038,13.719616,363201.727386842,1046003.77372146,186.029113769531,134,2.26958091712118,0.548349573675417 +-147.5366,59.2474006,13.719616,366906.044719044,1046003.79661064,176.731063842773,134,2.24731289172406,0.467465749505855 +-147.47177,59.2441653,13.719616,370609.928719659,1046003.78828748,196.358261108398,134,2.29304917745935,0.633592993732046 +-147.40695,59.2408978,13.719616,374313.953230312,1046003.79237375,187.076171875,134,2.27201847439355,0.557203477436765 +-147.34215,59.2375981,13.719616,378017.559266415,1046003.75202552,229.568405151367,134,2.36091211712054,0.880090560592928 +-147.27735,59.2342662,13.719616,381721.885461667,1046003.7806206,266.523223876953,230,2.42573505787354,1.11554598371715 +-147.21257,59.2309022,13.719616,385425.805810755,1046003.77499179,206.952651977539,430,2.31587099600294,0.716488352677896 +-147.1478,59.227506,13.719616,389129.89418624,1046003.78106303,251.851760864258,430,2.4011449916478,1.02622784448159 +-147.08305,59.2240777,13.719616,392833.590428554,1046003.75094589,321.192352294922,430,2.50676519602241,1.4098705737779 +-147.0183,59.2206173,13.719616,396538.033126139,1046003.80254339,468.780364990234,330,2.67096941283304,2.00630715778372 +-146.95358,59.2171247,13.719616,400241.532679225,1046003.74578311,611.407043457031,341,2.78633043752534,2.4253313267808 +-146.88886,59.2136,13.719616,403945.792381175,1046003.77110368,682.724060058594,341,2.8342452082077,2.59937145013628 +-146.82416,59.2100433,13.719616,407649.686109725,1046003.7687344,552.558471679688,440,2.74237824178556,2.26568440664828 +-140.75616,58.7275125,13.719616,759529.641583403,1046003.74449649,224,440,2.35024801833416,0.841355509963957 +-140.69328,58.7209321,13.719616,763233.901490152,1046003.79398893,208,440,2.31806333496276,0.724451553535809 +-140.63043,58.714321,13.719616,766937.829979969,1046003.78419062,221,440,2.34439227368511,0.820085774002676 +-140.5676,58.7076791,13.719616,770642.001118,1046003.81846305,211,440,2.32428245529769,0.74704117370595 +-140.5048,58.7010065,13.719616,774345.852746436,1046003.79111675,216,440,2.33445375115093,0.783986223421782 +-140.44202,58.6943031,13.719616,778049.958940085,1046003.80665987,218,440,2.3384564936046,0.798525326509967 +-140.37927,58.6875691,13.719616,781753.755233084,1046003.76925247,209,440,2.32014628611105,0.732017426639857 +-140.31654,58.6808044,13.719616,785457.815678819,1046003.78454267,216,440,2.33445375115093,0.783986223421782 +-140.25384,58.674009,13.719616,789161.580321892,1046003.73371001,223,440,2.34830486304816,0.834297415333461 +-140.19116,58.6671829,13.719616,792865.620948898,1046003.73449157,223,341,2.34830486304816,0.834297415333461 +-140.1285,58.6603263,13.719616,796569.938831894,1046003.80879067,257,241,2.40993312333129,1.05814884713856 +-140.06587,58.653439,13.719616,800273.978592537,1046003.81427702,207.006484985352,241,2.31598395100879,0.716898637499718 +-140.00327,58.6465211,13.719616,803977.743788577,1046003.76026888,191.677551269531,142,2.28257125251993,0.595534179654533 +-139.94069,58.6395727,13.719616,807681.803804736,1046003.7777072,191.955902099609,142,2.28320146998239,0.597823309360176 +-139.87814,58.6325937,13.719616,811385.600948773,1046003.73356594,192.200012207031,142,2.28375341091549,0.59982811636883 +-139.81561,58.6255842,13.719616,815089.704573512,1046003.75992305,192.51643371582,142,2.28446780796124,0.602423010348216 +-139.75311,58.6185441,13.719616,818793.556995901,1046003.72266756,192.480361938477,142,2.28438642664028,0.602127410161932 +-139.69063,58.6114736,13.719616,822497.725147279,1046003.7659321,194.843383789062,142,2.28968566323271,0.621375750018341 +-139.62818,58.6043725,13.719616,826201.653722685,1046003.74359825,229.811599731445,240,2.36137194590238,0.881760789976774 +-139.56575,58.597241,13.719616,829905.909600944,1046003.80093074,258.537628173828,240,2.4125237602694,1.06755877993916 +-139.50335,58.5900791,13.719616,833609.932666081,1046003.81255233,256.241821289062,240,2.40865001250005,1.05348822236318 +-139.44098,58.5828867,13.719616,837313.731100675,1046003.76603951,248.968795776367,240,2.39614491869673,1.00806615236042 +-139.37863,58.5756639,13.719616,841017.874114784,1046003.79744155,181.111999511719,143,2.2579472252952,0.506092684377206 +-139.31631,58.5684107,13.719616,844721.801575111,1046003.77974617,162.883682250977,143,2.21187757870188,0.338754578363978 +-139.25402,58.5611271,13.719616,848425.519216341,1046003.71147658,155.903411865234,143,2.19285561960212,0.269661393506005 +-139.19175,58.5538132,13.719616,852129.596169758,1046003.73037916,145.0380859375,143,2.16148205975632,0.155703669240549 +-139.1295,58.546469,13.719616,855834.038127761,1046003.83666843,132.983673095703,143,2.12379832427761,0.0188255859729163 +-139.06729,58.5390944,13.719616,859537.721521087,1046003.7608232,123.480690002441,143,2.09159904762748,-0.0981313774089152 +-139.0051,58.5316895,13.719616,863241.781306647,1046003.77060509,108.656341552734,40,2.03605507829564,-0.299882927849377 +-138.94294,58.5242544,13.719616,866945.654773312,1046003.74661334,101.974685668945,40,2.00849237530364,-0.399998532295008 +-138.8808,58.516789,13.719616,870649.915955589,1046003.8076449,96.4113845825195,40,1.98412831989285,-0.488495735740761 +-138.81869,58.5092933,13.719616,874354.004642699,1046003.82231874,100.229850769043,40,2.00099708374271,-0.427223570613499 +-138.75661,58.5017675,13.719616,878057.921406432,1046003.81101558,97.4401473999023,40,1.98873793225633,-0.471752307922258 +-138.69456,58.4942114,13.719616,881761.676942579,1046003.75058934,89.6050415039062,40,1.95233244532877,-0.603987427603643 +-138.63253,58.4866251,13.719616,885465.840207175,1046003.78388918,94.3269271850586,40,1.9746356869956,-0.522975687890741 +-138.57053,58.4790087,13.719616,889169.848362094,1046003.78822005,104.471748352051,143,2.01899886275667,-0.361835971015513 +-138.50856,58.4713621,13.719616,892873.709562935,1046003.75135976,119.04663848877,143,2.07571713677249,-0.155819010782927 +-138.44661,58.4636854,13.719616,896577.992686949,1046003.81785259,119.531326293945,143,2.07748173836945,-0.14940947411532 +-138.3847,58.4559787,13.719616,900281.568943495,1046003.72778986,122.279228210449,143,2.08735268892712,-0.113555364240063 +-138.32281,58.4482418,13.719616,903985.580831409,1046003.72868688,122.5,143,2.08813608870055,-0.110709832658411 +-138.26094,58.4404748,13.719616,907690.031305751,1046003.83178562,122.328918457031,143,2.08752913603639,-0.112914457976171 +-138.19911,58.4326778,13.719616,911393.791527506,1046003.77385957,122.572204589844,143,2.08839199741037,-0.10978029918073 +-138.1373,58.4248508,13.719616,915097.998750292,1046003.82753662,132.844161987305,143,2.12334247351928,0.0171698059058899 +-138.07553,58.4169938,13.719616,918801.526726514,1046003.7165155,143.510269165039,143,2.15688297899433,0.138998495204652 +-138.01378,58.4091067,13.719616,922505.515361735,1046003.70482625,154.53450012207,143,2.1890254516573,0.25574913029162 +-137.95205,58.4011897,13.719616,926209.96482582,1046003.81460034,161.422958374023,143,2.20796530229483,0.32454407377874 +-137.89036,58.3932428,13.719616,929913.748822727,1046003.76621793,169.320907592773,143,2.22871058771053,0.399896871702522 +-137.82869,58.3852659,13.719616,933618.007239749,1046003.82709087,176.651718139648,143,2.24711786580109,0.466757359687685 +-137.76706,58.3772591,13.719616,937321.61109456,1046003.72624174,181.106842041016,143,2.25793485784872,0.506047762281598 +-137.70545,58.3692225,13.719616,941025.694853701,1046003.75502128,185.465194702148,143,2.26826241978903,0.543560415028461 +-137.64387,58.3611559,13.719616,944729.703489087,1046003.74996731,188.598190307617,143,2.27553752115218,0.569985659700056 +-137.58232,58.3530595,13.719616,948433.63698305,1046003.73156977,192.681091308594,143,2.28483909740967,0.603771639601456 +-137.52079,58.3449333,13.719616,952138.066594133,1046003.84201593,198.239990234375,143,2.29719126763793,0.648638247530907 +-137.4593,58.3367773,13.719616,955841.865953351,1046003.79395106,194.020584106445,143,2.28784780771176,0.614700134190064 +-137.39784,58.3285915,13.719616,959545.606306928,1046003.72902764,185.484512329102,143,2.26830765254505,0.543724713309038 +-137.3364,58.3203759,13.719616,963249.858894933,1046003.79114041,184.937744140625,143,2.26702555582735,0.539067772083504 +-137.27499,58.3121306,13.719616,966954.06041921,1046003.84604532,179.356048583984,143,2.25371602735909,0.490723765769141 +-137.21362,58.3038555,13.719616,970657.653124242,1046003.73563044,171.970428466797,143,2.23545377331552,0.424390046516626 +-137.15227,58.2955508,13.719616,974361.76849652,1046003.77217376,165.907424926758,143,2.21986582262811,0.367770160375885 +-137.09095,58.2872163,13.719616,978065.851572448,1046003.78732747,125.178062438965,143,2.09752822506855,-0.0765949125872422 +-137.02966,58.2788522,13.719616,981769.902038582,1046003.80162095,141.890045166016,143,2.15195192695061,0.12108750671948 +-136.9684,58.2704585,13.719616,985473.92516404,1046003.81395706,163.940231323242,150,2.21468554355002,0.348953908165399 +-136.90717,58.2620351,13.719616,989177.929055893,1046003.81244432,109.253837585449,150,2.03843670068057,-0.291232195564629 +-136.84597,58.2535821,13.719616,992881.916146482,1046003.80681862,85.5786972045898,50,1.93236567077652,-0.676512451862278 +-136.7848,58.2450996,13.49631914,996585.888822111,1046003.80681611,118.690444946289,150,2.07441575792569,-0.160545990204994 +-136.72366,58.2365874,9.755804397,1000289.85804506,1046003.78978102,18.4319133758545,50,1.26557042070163,-3.09850312244682 +-153.86551,59.3740193,13.719616,7617.94815839205,1042299.77352213,13.0322551727295,32,1.11501957490876,-3.64534676585607 +-153.80012,59.3739359,13.719616,11321.867754772,1042299.77293712,16.497184753418,32,1.21740983813074,-3.27343610474309 +-153.73473,59.3738199,13.719616,15025.809297173,1042299.77439157,16.5442657470703,32,1.21864749745104,-3.26894057282864 +-153.66934,59.3736713,13.719616,18729.7799613722,1042299.77794887,23.7802791595459,32,1.37621694854755,-2.69660335164716 +-153.27701,59.3720945,13.719616,40954.0516261172,1042299.77600196,39.0677833557129,32,1.59181877074124,-1.91347599455291 +-153.21163,59.3717176,13.719616,44657.8608168846,1042299.77909077,44.9585075378418,32,1.6528118857719,-1.69193159159329 +-153.14625,59.371308,13.719616,48361.7566940247,1042299.7731363,47.5,32,1.67669360962487,-1.60518635403669 +-153.08087,59.3708659,13.719616,52065.7461545259,1042299.78072261,49.4000015258789,32,1.69372696233824,-1.54331635517883 +-153.01549,59.3703911,13.719616,55769.836669888,1042299.77973145,53.8064498901367,32,1.73083433856227,-1.40853177323348 +-152.95011,59.3698837,13.719616,59474.0352689572,1042299.78160237,57.213020324707,32,1.75749487515127,-1.31169309466752 +-152.88474,59.3693437,13.719616,63177.7826922934,1042299.77709948,69.4153900146484,32,1.8414557681127,-1.00672316660684 +-152.81937,59.3687711,13.719616,66881.6525430122,1042299.77491563,75.9680557250977,32,1.88063101150805,-0.864427500867215 +-152.754,59.3681659,13.719616,70585.6519921458,1042299.7753637,70.755615234375,32,1.8497609115961,-0.976556514951187 +-152.68863,59.3675281,13.719616,74289.7882101513,1042299.77877442,62.5662689208984,32,1.79634025701716,-1.17059558015473 +-152.62326,59.3668577,13.719616,77994.0683668703,1042299.7854963,69.7986679077148,32,1.84384713428721,-0.998037042097152 +-152.5579,59.3661547,13.719616,81697.9331999667,1042299.78359377,63.4105377197266,32,1.8021614360086,-1.14945139652794 +-152.49254,59.3654191,13.719616,85401.9563095022,1042299.78463732,61.3866157531738,32,1.78807369136637,-1.20062210611117 +-152.42719,59.3646509,13.719616,89105.5784317591,1042299.77561153,73.5321197509766,32,1.86647708579879,-0.91583859897588 +-152.36183,59.3638501,13.719616,92809.9395968883,1042299.7832129,80.2091369628906,32,1.90422384342809,-0.778731601268989 +-152.29648,59.3630167,13.719616,96513.9141081247,1042299.78048653,91.5001602172852,32,1.96142185451915,-0.570972099048517 +-152.23114,59.3621507,13.719616,100217.509130973,1042299.76621444,71.6165313720703,32,1.85501328285224,-0.957478403372854 +-152.16579,59.3612522,13.719616,103921.864384414,1042299.78166953,82.6580581665039,32,1.91728519845987,-0.731289031711675 +-152.10045,59.360321,13.719616,107625.854775708,1042299.77425018,60.982120513916,32,1.78520252189031,-1.21105101316156 +-152.03511,59.3593573,13.719616,111330.05327077,1042299.78190837,56.4720573425293,32,1.75183360987664,-1.33225642603095 +-151.96978,59.358361,12.72080283,115033.900908808,1042299.77667218,43.8747444152832,32,1.64221459957404,-1.73042395983054 +-151.83913,59.3562707,5.6284792,122441.704756191,1042299.7710664,17.8657550811768,32,1.25202137601893,-3.14771712001675 +-150.79459,59.3348608,13.36174113,181705.655432158,1042299.77375766,73.5738296508789,33,1.86672336244399,-0.914944051906165 +-150.5989,59.3299194,13.70254017,192817.631302449,1042299.76521938,96.3460083007812,33,1.98383372616474,-0.489565784246672 +-150.53368,59.3282073,13.719616,196521.791119071,1042299.77401924,286.736022949219,33,2.45748225724821,1.23086087339881 +-150.46847,59.3264627,13.719616,200225.763572693,1042299.77184823,156.221588134766,33,2.19374104849115,0.272877523957524 +-150.40327,59.3246856,13.71469204,203929.555760574,1042299.75798132,66.1944808959961,33,1.82082178073373,-1.0816716982936 +-150.33807,59.3228761,13.719616,207633.74059359,1042299.77413967,51.8987617492676,33,1.71515699615529,-1.46547635561468 +-150.27288,59.3210341,13.719616,211337.759328277,1042299.77831887,137.391937255859,133,2.13796124722112,0.0702693646043941 +-150.2077,59.3191596,13.719616,215041.619056653,1042299.76984639,159.512283325195,133,2.20279413175026,0.305760906361814 +-150.14252,59.3172526,13.719616,218745.893300467,1042299.78100533,167.716079711914,133,2.22457470241158,0.384874155797561 +-150.07735,59.3153132,13.719616,222450.022056534,1042299.79049662,172.236846923828,133,2.23612606641996,0.426832006963504 +-150.01219,59.3133413,13.719616,226154.013049468,1042299.78653763,171.268295288086,133,2.23367697501564,0.417936207942757 +-149.94704,59.311337,13.719616,229857.872681956,1042299.77968552,172.768325805664,133,2.23746412478233,0.431692216855532 +-149.8819,59.3093003,13.719616,233561.608003819,1042299.76935301,176.91667175293,133,2.24776876060412,0.469121595396143 +-149.81676,59.3072311,13.719616,237265.793198272,1042299.77953858,196.597961425781,133,2.29357901020962,0.635517497510367 +-149.75163,59.3051295,13.719616,240969.868197745,1042299.78623813,178.376800537109,133,2.25133836991743,0.482087435290035 +-149.68651,59.3029954,13.719616,244673.840771789,1042299.77775948,131.691314697266,133,2.119557133326,0.00342036988022601 +-149.6214,59.300829,13.719616,248377.71652179,1042299.77589955,114.585998535156,133,2.05913155366615,-0.216062582621872 +-149.55629,59.2986301,13.719616,252082.070381324,1042299.79580236,125.390228271484,133,2.09826369300881,-0.0739234831047373 +-149.4912,59.2963988,13.719616,255785.775799261,1042299.77278384,131.086532592773,133,2.11755807596866,-0.00384077702938306 +-149.42611,59.2941351,13.719616,259489.972674155,1042299.78285154,153.734283447266,133,2.18677072795306,0.247559330235625 +-149.36104,59.2918391,13.719616,263193.534395893,1042299.75912132,144.538436889648,133,2.15998335373143,0.15025994118486 +-149.29597,59.2895106,13.719616,266897.602408437,1042299.75755886,148.487731933594,133,2.17169057369609,0.192783905669745 +-149.23091,59.2871498,13.719616,270601.615737507,1042299.7609826,161.442901611328,133,2.20801895453248,0.32473895401974 +-149.16586,59.2847566,13.719616,274305.582190067,1042299.7578425,172.397689819336,133,2.23653144185159,0.428304446236865 +-149.10082,59.2823311,13.719616,278009.507966405,1042299.7589091,170.276596069336,133,2.23115495978628,0.408775528774903 +-149.03578,59.2798731,13.719616,281713.968157228,1042299.78393879,178.569442749023,133,2.25180714334935,0.483790154196043 +-148.97076,59.2773829,13.719616,285417.834414229,1042299.78175256,187.728454589844,133,2.27353010498555,0.562694151209253 +-148.90575,59.2748603,13.719616,289121.681834308,1042299.77158427,171.048248291016,133,2.23311863092423,0.415908142835479 +-148.84075,59.2723053,13.719616,292825.517432316,1042299.7531232,155.212249755859,133,2.19092599392884,0.262652442290628 +-148.77575,59.269718,13.719616,296529.913773596,1042299.78187226,157.526077270508,133,2.19735245829851,0.285995195176837 +-148.71077,59.2670984,13.719616,300233.744972281,1042299.76880885,128.985000610352,133,2.11053921005971,-0.0293353013944712 +-148.6458,59.2644465,13.719616,303937.584434629,1042299.75776398,111.787620544434,133,2.04839371207527,-0.255065488165074 +-148.58083,59.2617623,13.719616,307642.005564369,1042299.79481665,107.191650390625,133,2.03016095764683,-0.321292056395395 +-148.51588,59.2590458,13.719616,311345.882468065,1042299.78764906,105.373992919922,133,2.02273343701443,-0.348270931357733 +-148.45094,59.2562969,13.719616,315049.78947741,1042299.77067526,107.893028259277,133,2.03299338271492,-0.311003880093501 +-148.38601,59.2535158,13.719616,318753.731701525,1042299.76598521,109.88028717041,133,2.04091978577184,-0.282212921770095 +-148.32109,59.2507025,13.719616,322457.716069526,1042299.77339941,113.311470031738,133,2.05427387384717,-0.233707062244271 +-148.25618,59.2478568,13.719616,326161.751439403,1042299.7704783,121.438941955566,133,2.08435797474985,-0.124433020908442 +-148.19128,59.2449789,13.719616,329865.842846915,1042299.77935723,147.430130004883,133,2.16858624850038,0.181508110496314 +-148.12639,59.2420687,13.719616,333569.998200625,1042299.78877095,172.330139160156,133,2.23636123871485,0.427686219863431 +-148.06152,59.2391263,13.719616,337273.65702149,1042299.75896056,191.646026611328,133,2.28249981947525,0.595274714447243 +-147.99665,59.2361517,13.719616,340977.959088076,1042299.7908451,197.80094909668,230,2.29622837111587,0.645140732524745 +-147.9318,59.2331448,13.719616,344681.779470136,1042299.77108375,195.234252929688,230,2.29055601493583,0.624537115827184 +-147.86696,59.2301057,13.719616,348385.690510627,1042299.76153689,204.286651611328,230,2.31023999012273,0.69603493207189 +-147.80213,59.2270344,13.719616,352089.699116501,1042299.76216035,199.872634887695,230,2.3007533377359,0.661576702842758 +-147.73731,59.2239309,13.719616,355793.812191819,1042299.77292677,204.479400634766,230,2.31064956348635,0.697522619432423 +-147.6725,59.2207952,13.719616,359498.036637702,1042299.79382563,206.614410400391,230,2.31516060827325,0.713908021678811 +-147.60771,59.2176274,13.719616,363201.811846313,1042299.78130161,210.044525146484,230,2.32231136604702,0.73988161494264 +-147.54293,59.2144273,13.719616,366905.713282441,1042299.76669441,220.034042358398,230,2.34248987747978,0.813175727986983 +-147.47816,59.2111951,13.719616,370609.745678459,1042299.77229953,298.225189208984,230,2.47454432279389,1.29283516545907 +-147.4134,59.2079307,13.719616,374313.91699795,1042299.78704511,382.836273193359,230,2.5830130798399,1.68682465111578 +-147.34866,59.2046342,13.719616,378017.666577548,1042299.76520756,462.978607177734,330,2.6655609240648,1.98666198284111 +-140.64324,58.6818498,13.35761897,766937.947798398,1042299.80795471,281,440,2.44870631990508,1.19898416406666 +-140.58047,58.675214,13.719616,770641.944425245,1042299.80184745,258,440,2.41161970596323,1.06427499665636 +-140.0792,58.621024,13.719616,800273.50883533,1042299.71526756,337.771575927734,241,2.52862310012805,1.48926472035653 +-140.01665,58.6141125,13.719616,803977.628750224,1042299.74009563,200.283340454102,241,2.30164482622939,0.664814843507262 +-139.95412,58.6071705,13.719616,807682.040389211,1042299.83346963,194.596557617188,241,2.2891351533985,0.61937614116936 +-139.89163,58.6001979,13.719616,811385.619067033,1042299.74018001,195.801574707031,142,2.29181618023435,0.629114395878407 +-139.82915,58.5931948,13.719616,815090.067558086,1042299.83609299,196.236740112305,142,2.29278032075175,0.632616429430695 +-139.76671,58.5861612,13.719616,818793.692377791,1042299.75310035,197.341690063477,142,2.29521884324452,0.641473839148065 +-139.70429,58.5790971,13.719616,822497.632193554,1042299.7356616,212.732543945312,240,2.32783393360149,0.759941156598165 +-139.64189,58.5720026,13.719616,826201.89040652,1042299.79481233,250.291229248047,240,2.3984456312466,1.01642299703028 +-139.57952,58.5648777,13.719616,829905.906347325,1042299.80571318,259.700012207031,240,2.41447197004303,1.07463523391143 +-139.51718,58.5577223,13.719616,833609.688190357,1042299.75591828,259.674377441406,240,2.41442909909103,1.07447951437717 +-139.45486,58.5505365,13.719616,837313.805720373,1042299.78090193,213.497741699219,143,2.32939328557765,0.76560516805894 +-139.39257,58.5433203,13.719616,841017.698250766,1042299.75418987,170.645034790039,143,2.23209365625568,0.412185142282421 +-139.3303,58.5360738,13.719616,844721.935503626,1042299.81238563,156.345291137695,143,2.19408480554242,0.274126147685777 +-139.26806,58.5287969,13.719616,848425.959208943,1042299.81701596,148.761367797852,143,2.17249016285935,0.195688241736179 +-139.20585,58.5214896,13.719616,852129.775094263,1042299.76660953,136.576141357422,143,2.13537483857091,0.0608747901523065 +-139.14366,58.5141521,13.719616,855833.950354412,1042299.81037098,125.722816467285,143,2.099414101605,-0.0697448707240751 +-139.0815,58.5067843,13.719616,859537.926701959,1042299.80819145,108.98405456543,40,2.03736296105237,-0.295132324370038 +-139.01937,58.4993862,13.719616,863241.709816338,1042299.75863013,98.3630523681641,40,1.99283199715169,-0.456881495659824 +-138.95726,58.4919578,13.719616,866945.871802662,1042299.79080102,87.1138458251953,40,1.94008718701214,-0.648465700954338 +-138.89518,58.4844992,13.719616,870649.84937717,1042299.78474878,87.6488647460938,40,1.94274629535623,-0.63880706046353 +-138.83313,58.4770104,13.719616,874353.648171163,1042299.73906257,89.3753967285156,40,1.95121798260352,-0.608035474321089 +-138.7711,58.4694914,13.719616,878057.840241586,1042299.78455952,96.3018188476562,143,1.98363448970025,-0.490289467953476 +-138.7091,58.4619422,13.719616,881761.86477639,1042299.78875328,104.008331298828,143,2.01706812864676,-0.368848948389104 +-138.64713,58.4543629,13.719616,885465.724828644,1042299.76114767,98.5612106323242,143,1.99370602931415,-0.453706761372164 +-138.58518,58.4467534,13.719616,889169.994977725,1042299.82338712,101.969696044922,143,2.00847112474344,-0.400075720395172 +-138.52327,58.4391138,13.719616,892873.545381471,1042299.71777499,117.56827545166,143,2.07029014780293,-0.17553138373723 +-138.46138,58.4314441,13.719616,896577.514468265,1042299.71130185,124.430679321289,143,2.09492747213342,-0.0860415895764107 +-138.39951,58.4237443,13.719616,900281.907797451,1042299.80430818,122.5,143,2.08813608870055,-0.110709832658411 +-138.33768,58.4160144,13.719616,903985.5980593,1042299.72490696,123.267753601074,143,2.09084948158592,-0.10085401521931 +-138.27587,58.4082545,13.719616,907689.721043048,1042299.75433426,127.759429931641,143,2.10639296529311,-0.0443956458428444 +-138.21409,58.4004646,13.719616,911393.715828192,1042299.75572386,129.828552246094,143,2.11337021418465,-0.0190522863636865 +-138.15234,58.3926447,13.719616,915097.587919753,1042299.72778347,130.422912597656,143,2.11535389462137,-0.0118469928187421 +-138.09061,58.3847948,13.719616,918801.909248276,1042299.8075834,127.646957397461,143,2.1060104673875,-0.0457849874118196 +-138.02892,58.3769149,13.719616,922505.55244363,1042299.71771136,142.970443725586,143,2.15524626506228,0.133053483038765 +-137.96725,58.3690051,13.719616,926209.653184209,1042299.74502012,156.842636108398,143,2.19546413302698,0.279136258808961 +-137.90561,58.3610653,13.719616,929913.653170719,1042299.73905855,167.693862915039,143,2.22451716904077,0.384665178173092 +-137.844,58.3530957,13.719616,933617.552494541,1042299.72028389,177.27815246582,143,2.24865521699869,0.472341458041096 +-137.78241,58.3450961,13.719616,937321.928398952,1042299.80691328,180.935455322266,143,2.25752367765057,0.504554238439397 +-137.72086,58.3370667,13.719616,941025.648059882,1042299.73769594,183.761840820312,143,2.26425533272082,0.529005531060174 +-137.65933,58.3290075,13.719616,944729.849736553,1042299.79425476,184.278213500977,143,2.26547399330048,0.533432054125865 +-137.59783,58.3209184,13.719616,948433.975119268,1042299.82341318,186.612289428711,143,2.27094024099316,0.55328702596812 +-137.53636,58.3127995,13.719616,952138.026880198,1042299.83482063,178.093994140625,143,2.25064927400808,0.479584442259708 +-137.47492,58.3046508,13.719616,955842.010397126,1042299.82729791,135.977584838867,143,2.13346732320029,0.0539461498671497 +-137.41351,58.2964724,13.719616,959545.928279874,1042299.81050439,139.590560913086,143,2.14485605237055,0.0953132648804536 +-137.35213,58.2882642,13.719616,963249.788635704,1042299.77245133,122.973236083984,143,2.08981060179867,-0.104627523132423 +-137.29078,58.2800263,13.719616,966953.594042119,1042299.72281558,120.278091430664,143,2.08018652811066,-0.139584905751385 +-137.22945,58.2717587,13.719616,970657.916253799,1042299.8066146,122.2265625,143,2.08716559783434,-0.114234932490148 +-137.16816,58.2634614,13.719616,974361.627724615,1042299.73095768,114.733222961426,143,2.05968919348629,-0.214037075628879 +-137.10689,58.2551345,13.719616,978065.863816721,1042299.79841547,109.380699157715,143,2.03894069504307,-0.289401544185696 +-137.04565,58.2467779,13.719616,981770.066194853,1042299.85090178,136.103485107422,143,2.13386924602291,0.0554060482790689 +-136.98445,58.2383916,13.719616,985473.673725776,1042299.73892978,167.695816040039,150,2.2245222272251,0.384683550942344 +-136.92327,58.2299758,13.719616,989177.818881602,1042299.77924796,154.777404785156,150,2.18970756039491,0.258226743919852 +-136.86212,58.2215304,13.719616,992881.943308395,1042299.81213016,115.335876464844,150,2.06196442027952,-0.205772802501494 +-136.801,58.2130555,13.719616,996586.04939454,1042299.84730527,94.9635391235352,50,1.97755689163715,-0.512365038837835 +-136.73992,58.204551,13.719616,1000289.57879349,1042299.72228578,59.1684455871582,50,1.77209016008676,-1.25867885387273 +-136.67886,58.196017,13.09237754,1003993.66672434,1042299.74750131,42.9574356079102,50,1.63303834777122,-1.76375472554141 +-153.80032,59.3408081,13.719616,11321.675968525,1038595.77570756,13.0390663146973,32,1.11524649408819,-3.64452253062718 +-153.73499,59.3406922,13.719616,15025.8625394566,1038595.77656656,19.0888404846191,32,1.28077954880092,-3.04325922807282 +-153.66967,59.3405437,13.719616,18729.5112059329,1038595.77365719,11.3492288589478,32,1.05496635371582,-3.86347720612468 +-153.34305,59.3393125,11.19963154,37249.575469423,1038595.77637573,12.8916463851929,32,1.11030838440889,-3.66245915445923 +-153.27773,59.3389685,13.719616,40953.54909449,1038595.77570563,42.5731201171875,32,1.62913548010482,-1.77793105489512 +-153.21241,59.3385919,13.719616,44657.6019815453,1038595.77391294,50.0765571594238,32,1.69963446281296,-1.52185862728615 +-153.14709,59.3381827,13.719616,48361.7413007416,1038595.77120325,49.4000015258789,32,1.69372696233824,-1.54331635517883 +-153.08177,59.337741,13.719616,52065.9740672524,1038595.77897968,53,32,1.72427586960079,-1.43235400447501 +-153.01646,59.3372667,13.719616,55769.7405937493,1038595.77790568,57.6149787902832,32,1.7605354063447,-1.30064901751895 +-152.95115,59.3367598,13.719616,59473.6150383972,1038595.77552239,59.5309982299805,32,1.77474316496629,-1.24904238290729 +-152.88584,59.3362203,13.719616,63177.6045696158,1038595.77210651,76.316650390625,32,1.88261930052214,-0.857205467653876 +-152.82053,59.3356483,13.719616,66881.7161567394,1038595.77913151,79.9053802490234,32,1.90257602254046,-0.78471695706775 +-152.75522,59.3350436,13.719616,70585.9573532519,1038595.77455145,72.8139114379883,32,1.86221436123025,-0.931322031311529 +-152.68992,59.3344064,13.719616,74289.7679285416,1038595.76986776,69.9869003295898,32,1.84501675934332,-0.993788630049135 +-152.62462,59.3337367,13.719616,77993.7220050727,1038595.77549847,72.5335922241211,32,1.8605391864164,-0.937406744377912 +-152.55932,59.3330344,13.719616,81697.8269579252,1038595.78063024,74.4445037841797,32,1.8718326394379,-0.896385699531443 +-152.49403,59.3322995,13.719616,85401.5229626789,1038595.77278677,68.7113037109375,32,1.83702818881299,-1.02280539838034 +-152.42873,59.331532,13.719616,89105.951162031,1038595.77753047,75.2105026245117,32,1.87627849103558,-0.880237097556277 +-152.36344,59.330732,13.719616,92809.9844653413,1038595.78018058,85.2733917236328,32,1.93081353725987,-0.682150243817738 +-152.29816,59.3298994,13.719616,96513.6302887715,1038595.76832247,83.9073333740234,32,1.9237999191683,-0.707625706612219 +-152.23287,59.3290343,13.719616,100218.029475238,1038595.78209501,78.1946792602539,32,1.89317720259275,-0.81885615380816 +-152.16759,59.3281366,13.719616,103922.055482698,1038595.78116945,64.065559387207,32,1.80662462253303,-1.13323982915095 +-152.10232,59.3272064,13.719616,107625.715151848,1038595.7755384,65.4533157348633,32,1.81593165193918,-1.09943404185713 +-152.03705,59.3262436,13.719616,111329.582928683,1038595.76962302,61.3823204040527,32,1.78804330181539,-1.20073248963437 +-151.97178,59.3252483,7.223905476,115033.665630112,1038595.77512388,13.1819591522217,32,1.1199799615302,-3.62732922581168 +-150.9281,59.3048994,3.805865852,174297.762706828,1038595.77419216,43.7667388916016,33,1.6411441880537,-1.73431199999827 +-150.86291,59.3033513,13.34855277,178002.054377777,1038595.78744505,89.6776885986328,33,1.95268440598973,-0.60270900602346 +-150.79774,59.3017707,13.02033808,181705.555123008,1038595.7609203,138.048431396484,33,2.14003147624351,0.0777890273159107 +-150.73256,59.3001577,8.430314658,185409.972462272,1038595.78705274,12.6267852783203,33,1.10129279524289,-3.6952063476155 +-150.6674,59.2985122,12.08334771,189113.613055928,1038595.77179486,41.3865280151367,33,1.61685899424047,-1.82252275561234 +-150.60224,59.2968342,13.719616,192817.617981179,1038595.77076188,114.568016052246,33,2.05906339258131,-0.216310163137121 +-150.53708,59.2951237,13.719616,196521.994335059,1038595.78486496,211.927764892578,133,2.32618785784212,0.753962139603338 +-150.47194,59.2933808,13.719616,200225.614640721,1038595.76589864,166.314498901367,133,2.22093011162709,0.371635961798513 +-150.4068,59.2916054,13.719616,203929.620542198,1038595.7617111,148.738571166992,33,2.17242360519186,0.195446485290414 +-150.34166,59.2897976,13.719616,207634.018515905,1038595.78442958,95.9527206420898,133,1.98205729322569,-0.496018295725742 +-150.27654,59.2879574,13.719616,211337.681640699,1038595.77138792,122.002586364746,133,2.08636903749468,-0.117128267004773 +-150.21142,59.2860847,13.719616,215041.751588255,1038595.77383489,149.164337158203,133,2.17366500258207,0.199955594941746 +-150.14631,59.2841796,13.719616,218745.667807558,1038595.77100999,170.939437866211,133,2.23284227144947,0.414904326342295 +-150.0812,59.282242,13.719616,222450.00499926,1038595.78460634,184.135131835938,133,2.26513665709103,0.532206752727825 +-150.01611,59.2802721,13.719616,226153.634927192,1038595.76988821,166.131912231445,133,2.22045306396748,0.369903188535832 +-149.95102,59.2782697,13.719616,229857.699947829,1038595.77147677,167.320953369141,133,2.22355033045902,0.381153344480979 +-149.88594,59.2762349,13.719616,233561.63945888,1038595.76644751,180.941131591797,133,2.25753730203316,0.504603726085753 +-149.82086,59.2741677,13.719616,237266.027494018,1038595.78995503,193.662963867188,133,2.28704657412116,0.611789825094174 +-149.7558,59.2720681,13.719616,240969.737117102,1038595.77054838,184.718551635742,133,2.26651051465213,0.537196995527717 +-149.69074,59.2699361,13.719616,244673.909347081,1038595.77970139,121.108665466309,133,2.08317521853167,-0.12872912908512 +-149.62569,59.2677718,13.719616,248377.983497145,1038595.79232308,125.41455078125,133,2.0983479269046,-0.0736175215525046 +-149.56065,59.265575,13.719616,252081.968064426,1038595.78559734,126.987930297852,133,2.10376244493911,-0.0539504465938525 +-149.49562,59.2633459,13.719616,255785.8686004,1038595.78135003,133.756683349609,133,2.12631549139861,0.0279686554274073 +-149.4306,59.2610844,13.719616,259489.692872997,1038595.76795651,156.318389892578,133,2.19401007308676,0.273854698076053 +-149.36558,59.2587906,13.719616,263194.014121792,1038595.79574975,162.820602416992,133,2.21170935724793,0.338143550028071 +-149.30058,59.2564644,13.719616,266897.706153655,1038595.77443676,153.230224609375,133,2.18534443818429,0.242378638691833 +-149.23558,59.2541058,13.719616,270601.909972589,1038595.78342058,144.287155151367,133,2.15922767069724,0.147515084711262 +-149.17059,59.2517149,13.719616,274306.064800195,1038595.79382148,154.000671386719,133,2.18752261420602,0.25029039571607 +-149.10562,59.2492917,13.719616,278009.610635374,1038595.76339272,167.325973510742,133,2.22356336042954,0.381200673053034 +-149.04065,59.2468361,13.719616,281713.689276673,1038595.76378381,172.576080322266,133,2.23698060074225,0.429935919530457 +-148.97569,59.2443483,13.719616,285417.739060989,1038595.77563915,175.602966308594,133,2.24453184779203,0.457364204155734 +-148.91074,59.2418281,13.719616,289121.768648642,1038595.776328,168.285430908203,133,2.22604651912464,0.390220214197703 +-148.8458,59.2392756,13.719616,292825.784184253,1038595.77668329,157.784606933594,133,2.19806463227086,0.288582014319098 +-148.78087,59.2366908,13.719616,296529.792644149,1038595.77640592,165.704193115234,133,2.21933349830327,0.365836606487564 +-148.71595,59.2340737,13.719616,300233.801002187,1038595.77521385,140.797958374023,133,2.14859635741032,0.108899120374262 +-148.65104,59.2314243,13.719616,303937.816229744,1038595.77284212,118.384063720703,133,2.07329324373844,-0.164623282130538 +-148.58614,59.2287427,13.719616,307641.844385263,1038595.78018592,119.044921875,133,2.0757108743423,-0.155841757716849 +-148.52125,59.2260288,13.719616,311345.893323674,1038595.78586948,110.195960998535,133,2.04216567665556,-0.277687490467753 +-148.45637,59.2232826,13.719616,315049.970008706,1038595.78967891,111.132461547852,133,2.04584093393571,-0.26433790700338 +-148.39151,59.2205042,13.719616,318753.513469135,1038595.7545606,113.948280334473,133,2.0567077753533,-0.224866437269353 +-148.32665,59.2176935,13.719616,322457.665563288,1038595.7646289,114.736083984375,133,2.05970002305209,-0.21399773955482 +-148.2618,59.2148506,13.719616,326161.865292879,1038595.78342002,123.937339782715,133,2.09320217012505,-0.0923083789210371 +-148.19697,59.2119754,13.719616,329865.553564801,1038595.74997735,130.498352050781,133,2.11560502738487,-0.0109348069413 +-148.13214,59.2090681,13.719616,333569.869334879,1038595.78522771,143.818161010742,133,2.15781373117023,0.142379252770638 +-148.06733,59.2061285,13.719616,337273.687501809,1038595.76688378,173.901641845703,133,2.24030368229692,0.442006300238929 +-148.00253,59.2031567,13.719616,340977.580991418,1038595.7556552,192.156753540039,134,2.2836556527797,0.599473030916696 +-147.93774,59.2001527,13.719616,344681.556713141,1038595.7514606,192.586044311523,230,2.28462481291265,0.602993297145409 +-147.87296,59.1971166,13.719616,348385.620543566,1038595.76536804,201.343063354492,230,2.30393667194315,0.673139481297522 +-147.80819,59.1940482,13.719616,352089.781435565,1038595.77506385,215.6416015625,230,2.33373254865824,0.781366610116633 +-147.74343,59.1909477,13.719616,355794.044219117,1038595.80278111,212.057510375977,230,2.32645365834293,0.754927602889288 +-147.67869,59.187815,13.719616,359497.84983286,1038595.783241,216.186614990234,230,2.33482880147746,0.785348513257746 +-147.61396,59.1846501,13.719616,363201.772161024,1038595.76946295,236.388244628906,330,2.37362587567903,0.926270560545309 +-147.54924,59.1814532,13.719616,366905.815927091,1038595.78372088,287.453369140625,330,2.45856740322589,1.23480243332124 +-147.48453,59.178224,13.719616,370609.991240228,1038595.792666,435.110321044922,330,2.63859938510769,1.8887299777595 +-147.41984,59.1749628,13.719616,374313.73471184,1038595.77336646,604.457214355469,430,2.78136556536727,2.4072974939871 +-140.09249,58.5886069,13.71672223,800273.885141458,1038595.79255896,514.910583496094,440,2.71173181842796,2.15436784965339 +-140.03,58.5817018,13.719616,803977.787739427,1038595.77632581,287.758758544922,241,2.45902855117182,1.2364774542856 +-139.96753,58.5747661,13.719616,807681.981311051,1038595.81369182,206.554061889648,241,2.31503373980602,0.71344719919398 +-139.90509,58.5678,13.719616,811385.900009354,1038595.80439892,199.044311523438,241,2.29894977041907,0.655025631558662 +-139.84268,58.5608033,13.719616,815089.554346656,1038595.7249954,201.676895141602,241,2.30465614666458,0.67575281884427 +-139.78029,58.5537762,13.719616,818793.512402179,1038595.71903493,200.298095703125,241,2.30167682033923,0.664931055246207 +-139.71792,58.5467186,13.719616,822497.782332994,1038595.77569225,209.120819091797,241,2.32039727129974,0.732929076483463 +-139.65558,58.5396306,13.719616,826201.800551829,1038595.78158896,260.057464599609,241,2.41506932412851,1.07680499445173 +-139.59327,58.5325121,13.719616,829905.575224849,1038595.7242568,261.429046630859,240,2.41735383913847,1.08510300503339 +-139.53098,58.5253633,13.719616,833609.67429581,1038595.74950658,260.493255615234,240,2.41579648353955,1.07944624498459 +-139.46872,58.5181841,13.719616,837313.538919916,1038595.72048602,192.971649169922,143,2.28549350841978,0.606148647177686 +-139.40648,58.5109745,13.719616,841017.741830021,1038595.76231698,176.266860961914,143,2.24617067047184,0.463316875895391 +-139.34427,58.5037346,13.719616,844721.719328379,1038595.75887757,157.005233764648,143,2.19591412984376,0.280770775689375 +-139.28208,58.4964644,13.719616,848426.044105669,1038595.83642344,139.199035644531,143,2.143636226541,0.0908825092945681 +-139.21993,58.4891638,13.719616,852129.590345615,1038595.72761972,128.358108520508,143,2.10842330872606,-0.0370208589766566 +-139.15779,58.481833,13.719616,855834.05978277,1038595.83772961,106.793754577637,40,2.02854585539124,-0.327158568783783 +-139.09569,58.4744719,13.719616,859537.759589767,1038595.76945627,88.8478622436523,40,1.94864698276648,-0.617374079565623 +-139.03361,58.4670805,13.719616,863241.829423327,1038595.77964781,87.6251602172852,40,1.94262882505653,-0.639233746121379 +-138.97156,58.459659,13.719616,866945.702951802,1038595.75977996,85.6995391845703,40,1.9329784866824,-0.674286529577028 +-138.90953,58.4522072,13.719616,870649.957804948,1038595.81773967,84.8933563232422,40,1.92887370408313,-0.689196271599162 +-138.84753,58.4447252,13.719616,874354.030126396,1038595.83301693,76.3092727661133,40,1.88257731471067,-0.857357972105076 +-138.78556,58.437213,13.719616,878057.925540369,1038595.80420601,92.5299835205078,143,1.96628248482008,-0.553316902433508 +-138.72362,58.4296707,13.719616,881761.647117235,1038595.74079404,106.104415893555,143,2.02573345890883,-0.337373995545749 +-138.6617,58.4220983,13.719616,885465.767428269,1038595.77472359,100.445205688477,143,2.00192921243589,-0.42383781314386 +-138.59981,58.4144957,13.719616,889169.727628455,1038595.76152706,95.4921035766602,143,1.97996746043327,-0.50360916492547 +-138.53795,58.406863,13.719616,892873.530740012,1038595.7107208,118.589637756348,143,2.07404674246967,-0.161886359668764 +-138.47611,58.3992003,13.719616,896577.746728021,1038595.76682772,126.936416625977,143,2.1035862341581,-0.0545904944460553 +-138.4143,58.3915075,13.719616,900281.816729634,1038595.78374331,127.541732788086,143,2.10565231303693,-0.0470859062404867 +-138.35252,58.3837846,13.719616,903985.746297122,1038595.76013955,129.414077758789,143,2.11198152177635,-0.0240964135628995 +-138.29077,58.3760318,13.719616,907689.535739379,1038595.71642701,131.075576782227,143,2.11752177745032,-0.00397262360863536 +-138.22904,58.3682489,13.719616,911393.762782981,1038595.76680029,129.470443725586,143,2.11217063643329,-0.0234094951501957 +-138.16734,58.3604361,13.719616,915097.8606952,1038595.79556407,131.3251953125,143,2.11834805537713,-0.000971346335264194 +-138.10567,58.3525933,13.719616,918801.837592719,1038595.79056726,131.469482421875,143,2.11882495317619,0.000760882591103516 +-138.04403,58.3447205,13.719616,922505.698967501,1038595.75053387,128.033874511719,143,2.10732488814161,-0.0410106360598539 +-137.98241,58.3368179,13.719616,926210.011956666,1038595.83536736,137.956344604492,143,2.13974167845318,0.0767363990249197 +-137.92083,58.3288853,13.719616,929913.653359333,1038595.74372907,154.916091918945,143,2.19009653246945,0.259639601518257 +-137.85927,58.3209228,13.719616,933617.759938707,1038595.76471405,166.964904785156,143,2.22262519414221,0.377792985318139 +-137.79774,58.3129305,13.719616,937321.767443913,1038595.76846248,174.758758544922,143,2.24243895089788,0.449762205263954 +-137.73624,58.3049084,13.719616,941025.681276318,1038595.75374161,174.20849609375,143,2.2410693315939,0.444787357023613 +-137.67477,58.2968564,13.719616,944729.509550401,1038595.70849233,179.560256958008,143,2.25421021822307,0.492518808043239 +-137.61332,58.2887746,13.719616,948433.821945486,1038595.78516064,172.595825195312,143,2.23703028664821,0.430116392922689 +-137.5519,58.280663,13.719616,952138.056855362,1038595.84085125,162.086502075195,143,2.20974685002225,0.331015163629048 +-137.49052,58.2725217,13.719616,955841.649918519,1038595.7412794,134.068023681641,143,2.12732520742221,0.0316362322267548 +-137.42916,58.2643506,13.719616,959545.743213507,1038595.76173297,127.733383178711,143,2.10630441516154,-0.0447172851954303 +-137.36783,58.2561498,13.719616,963249.772346542,1038595.76850253,126.233924865723,143,2.10117608551062,-0.0633448422585892 +-137.30653,58.2479193,13.719616,966953.742646167,1038595.76042763,118.97233581543,143,2.07544598828809,-0.156803899471746 +-137.24526,58.2396591,13.719616,970657.65943476,1038595.73635911,119.167129516602,143,2.07615647823799,-0.154223197179689 +-137.18402,58.2313693,13.719616,974361.525229464,1038595.70597604,118.384521484375,143,2.07329492305106,-0.164617182387776 +-137.1228,58.2230498,13.719616,978065.91510871,1038595.80460395,114.692779541016,143,2.05953607784723,-0.214593235333508 +-137.06162,58.2147007,13.719616,981769.697578802,1038595.74794764,143.294311523438,143,2.1562289501809,0.136622875875844 +-137.00046,58.206322,13.719616,985474.011886045,1038595.83000156,147.357131958008,143,2.16837116017272,0.180726848297932 +-136.93934,58.1979137,13.719616,989177.72931345,1038595.75344206,183.129653930664,150,2.26275867469873,0.52356924193521 +-136.87824,58.1894759,13.719616,992881.986246143,1038595.82532031,165.147384643555,150,2.21787170037762,0.360526939182952 +-136.81718,58.1810085,13.719616,996585.656783564,1038595.73529477,113.514961242676,150,2.05505310520251,-0.230876671546888 +-136.75614,58.1725116,13.719616,1000289.87727854,1038595.79266412,98.1055908203125,50,1.99169375756573,-0.461015906721983 +-136.69514,58.1639853,13.719616,1003993.51608092,1038595.7064742,63.9676628112793,50,1.80596048317485,-1.1356521728641 +-136.63416,58.1554294,12.38135633,1007697.71811688,1038595.75587629,94.7727813720703,150,1.97668362639686,-0.515536987445281 +-153.9963,59.3078318,13.719616,209.992395345019,1034891.77573537,12.2236413955688,32,1.08720060054034,-3.74639322108795 +-153.80051,59.3076798,13.719616,11322.0294194696,1034891.78028354,20.1000003814697,32,1.30319606566279,-2.9618360405196 +-153.73525,59.307564,13.719616,15025.8867790408,1034891.77882087,23.7999992370605,32,1.37657694313465,-2.69529574855413 +-153.66999,59.3074156,13.719616,18729.7731864804,1034891.7722377,21.2889175415039,32,1.3281535798177,-2.87118322552521 +-153.60473,59.3072347,13.719616,22433.6957435093,1034891.77179536,28.8083457946777,32,1.45951832135334,-2.39402898903757 +-153.47421,59.3067753,13.49815776,29841.6779352097,1034891.77856449,11.885799407959,32,1.07502839656398,-3.790606140223 +-153.40895,59.3064967,13.69236948,33545.7519610319,1034891.77484604,16.5755863189697,32,1.21946889940499,-3.26595700648042 +-153.34369,59.3061856,13.719616,37249.8907196612,1034891.77776897,23.1290130615234,32,1.36415710137939,-2.74040815878499 +-153.27844,59.3058419,13.719616,40953.5339197409,1034891.77015596,40.6193161010742,32,1.60873260700503,-1.85204011355333 +-153.21318,59.3054657,13.719616,44657.8236896493,1034891.77514991,49.4000015258789,32,1.69372696233824,-1.54331635517883 +-153.14793,59.3050569,13.719616,48361.6322123092,1034891.76888477,53.1178321838379,32,1.72524034253074,-1.42885076350544 +-153.08268,59.3046156,13.719616,52065.5340463809,1034891.76892968,54.9000015258789,32,1.73957235652078,-1.37679279792956 +-153.01743,59.3041418,13.719616,55769.5363245721,1034891.77552483,54.0105934143066,32,1.73247894890021,-1.40255807906758 +-152.95218,59.3036354,13.719616,59473.6463555366,1034891.77774887,65.8603286743164,32,1.818623893717,-1.08965505127777 +-152.88693,59.3030964,13.719616,63177.8713040062,1034891.77587791,80.7681655883789,32,1.90724021926994,-0.767775263251991 +-152.82169,59.3025249,13.719616,66881.6505888205,1034891.77131376,89.4129409790039,32,1.95140037997085,-0.60737295502154 +-152.75645,59.3019209,13.719616,70585.558887718,1034891.7733228,72.1989974975586,32,1.85853116731616,-0.944700442895708 +-152.69121,59.3012843,13.719616,74289.6035511756,1034891.77105526,68.7740249633789,32,1.8374244419403,-1.02136609392005 +-152.62597,59.3006152,13.719616,77993.7915103783,1034891.77603638,73.6201782226562,32,1.86699686446928,-0.913950614485048 +-152.56074,59.2999136,13.719616,81697.562347214,1034891.77632835,76.7618026733398,32,1.88514516515009,-0.84803080637163 +-152.4955,59.2991794,13.719616,85402.0585372172,1034891.7851811,74.8007659912109,32,1.87390604524485,-0.888854497831661 +-152.43028,59.2984127,13.719616,89105.5843355735,1034891.7755935,82.8616409301758,32,1.91835352949165,-0.727408548472206 +-152.36505,59.2976134,13.719616,92809.8497853518,1034891.77538415,89.5984420776367,32,1.95230045828972,-0.604103613659494 +-152.29983,59.2967816,13.719616,96513.7266652932,1034891.76877318,86.1205139160156,32,1.9351066127704,-0.666556568197763 +-152.23461,59.2959174,13.719616,100217.789350473,1034891.78080689,86.9531555175781,32,1.93928534710935,-0.651378212349166 +-152.16939,59.2950205,13.719616,103922.045856835,1034891.77842552,79.1463394165039,32,1.89843083318477,-0.799773467962447 +-152.10418,59.2940912,13.719616,107625.93486939,1034891.77944056,75.2957458496094,32,1.87677043959736,-0.878450199963784 +-152.03897,59.2931294,13.71917757,111330.031354991,1034891.78827132,63.5707321166992,32,1.80325721304146,-1.14547122157867 +-151.12651,59.2762508,9.47485636,163185.915218975,1034891.77748129,102.977188110352,33,2.01274102883098,-0.384566209997252 +-151.06137,59.2748016,10.78555518,166890.004592192,1034891.78465913,96.3335037231445,33,1.9837773561956,-0.489770536064196 +-150.99624,59.2733199,4.345529702,170593.847685172,1034891.77663559,21.8246784210205,33,1.33894785324793,-2.83197534343424 +-150.86599,59.2702592,12.30092332,178001.957478893,1034891.78746822,51.2227973937988,33,1.70946329259231,-1.48615751210022 +-150.80088,59.2686801,13.719616,181705.671328158,1034891.76833969,67.8018798828125,33,1.83124173533334,-1.04382344903666 +-150.73577,59.2670686,13.71868804,185409.734274856,1034891.77083897,53.0213050842285,33,1.72445041339902,-1.43172001158007 +-150.67067,59.2654247,13.719616,189113.585835803,1034891.76736245,67.1308517456055,33,1.82692215747942,-1.05951338873239 +-150.60557,59.2637483,13.719616,192817.801191469,1034891.77499519,156.459396362305,133,2.19440165035698,0.275277018488773 +-150.54048,59.2620395,13.719616,196521.819306169,1034891.77621991,128.407791137695,133,2.10859137533295,-0.036410393089446 +-150.4754,59.2602983,13.719616,200225.647238904,1034891.77028833,129.949935913086,133,2.11377606965773,-0.0175781034427614 +-150.41032,59.2585246,13.719616,203929.860198056,1034891.77601273,138.693267822266,133,2.14205538091035,0.085140426745775 +-150.34525,59.2567186,13.719616,207633.896495122,1034891.78541661,123.350952148438,133,2.09114250616638,-0.0997896663055359 +-150.28019,59.2548801,13.719616,211337.764403002,1034891.77547642,112.031311035156,133,2.04933941828954,-0.25163041326341 +-150.21513,59.2530092,13.719616,215042.037916815,1034891.78905796,116.000442504883,133,2.06445964592573,-0.196709430746133 +-150.15009,59.2511059,13.719616,218745.58899288,1034891.76129675,139.237762451172,133,2.14375703556229,0.0913213221422125 +-150.08505,59.2491702,13.719616,222449.559773741,1034891.75686746,184.886077880859,133,2.26690420955203,0.53862700777588 +-150.02001,59.2472022,13.719616,226153.956636434,1034891.7879769,184.818130493164,133,2.26674457287385,0.538047161795865 +-149.95499,59.2452017,13.719616,229857.652860045,1034891.76414513,166.041107177734,133,2.22021562063263,0.36904072657058 +-149.88997,59.2431689,13.719616,233561.78923128,1034891.77576499,179.478454589844,133,2.25401232135807,0.49179999014416 +-149.82496,59.2411037,13.719616,237265.805913669,1034891.77704792,189.049072265625,133,2.27657455045863,0.573752446138717 +-149.75996,59.2390061,13.719616,240969.709946154,1034891.7674366,159.986663818359,133,2.20408378220913,0.310445284931327 +-149.69497,59.2368762,13.719616,244673.507641424,1034891.75754769,123.566329956055,133,2.09190014788589,-0.0970376953277988 +-149.62998,59.2347139,13.719616,248377.774283789,1034891.77310027,130.637161254883,133,2.11606673461337,-0.00925775450299965 +-149.565,59.2325193,13.719616,252081.948612983,1034891.78845954,127.525650024414,133,2.10559754589698,-0.0472848361248856 +-149.50003,59.2302923,13.719616,255786.038383976,1034891.7919804,132.491714477539,133,2.12218872001475,0.0129790438633836 +-149.43507,59.228033,13.719616,259490.049857465,1034891.79434561,139.885498046875,133,2.14577269344343,0.0986427668925536 +-149.37012,59.2257414,13.719616,263193.990027156,1034891.79509902,140.615478515625,133,2.14803312910435,0.106853314405609 +-149.30518,59.2234174,13.719616,266897.866674275,1034891.78264946,143.738693237305,133,2.1575736922641,0.141507362949657 +-149.24025,59.2210611,13.719616,270601.686020233,1034891.76772894,150.875457763672,133,2.17861860077855,0.217948477489036 +-149.17532,59.2186725,13.719616,274306.022599103,1034891.79123708,171.273056030273,133,2.23368904692494,0.417980056562994 +-149.11041,59.2162516,13.719616,278009.748301646,1034891.77073561,185.531280517578,133,2.26841714204218,0.544122410413999 +-149.0455,59.2137984,13.719616,281714.005204368,1034891.7890204,194.248611450195,133,2.28835792301131,0.616553018559444 +-148.98061,59.2113129,13.719616,285417.665193389,1034891.76145645,176.125091552734,133,2.24582123187092,0.462047615157143 +-148.91572,59.2087952,13.719616,289121.869485433,1034891.78425209,174.647323608398,133,2.24216193465726,0.448756003209711 +-148.85084,59.2062451,13.719616,292826.059208152,1034891.79237298,171.086288452148,133,2.23321520481762,0.416258926781217 +-148.78598,59.2036628,13.719616,296529.67206644,1034891.76316018,158.597137451172,133,2.20029534439155,0.296684597450076 +-148.72112,59.2010483,13.719616,300233.85009217,1034891.7850697,135.694641113281,133,2.13256269673206,0.0506602883284055 +-148.65627,59.1984014,13.719616,303938.034470963,1034891.79145026,125.759429931641,133,2.09954056003993,-0.0692855375936032 +-148.59144,59.1957224,13.719616,307641.66192544,1034891.76915855,134.853286743164,133,2.12986153586139,0.0408489010580913 +-148.52661,59.1930111,13.719616,311345.876288092,1034891.78776112,125.70890045166,133,2.09936602772732,-0.0699194887694646 +-148.4618,59.1902675,13.719616,315049.549425282,1034891.75383547,113.146659851074,133,2.05364173787839,-0.236003160512448 +-148.39699,59.1874918,13.719616,318753.821504587,1034891.78378296,113.350173950195,133,2.05442219094292,-0.233168332218572 +-148.3322,59.1846838,13.719616,322457.566227889,1034891.75969996,123.057411193848,133,2.09010777442784,-0.103548107321777 +-148.26741,59.1818436,13.719616,326161.924677863,1034891.78911054,126.687973022461,133,2.10273538759139,-0.0576810120321179 +-148.20264,59.1789712,13.719616,329865.768677693,1034891.77419521,129.731781005859,133,2.11304638028398,-0.0202285435223148 +-148.13788,59.1760666,13.719616,333569.672688882,1034891.76337362,135.156707763672,133,2.13083760439996,0.0443942605878478 +-148.07313,59.1731299,13.719616,337273.642626759,1034891.7676628,173.03352355957,133,2.23813025160569,0.434111779609489 +-148.00839,59.1701609,13.719616,340977.687382307,1034891.76468941,199.351364135742,134,2.29961921182986,0.657457233840237 +-147.94366,59.1671598,13.719616,344681.811858001,1034891.77663855,201.770217895508,230,2.30485706300018,0.676482604322408 +-147.87894,59.1641265,13.719616,348386.023953623,1034891.79230691,205.623687744141,230,2.31307314370841,0.706325754557616 +-147.81424,59.1610611,13.719616,352089.761982826,1034891.76975795,211.116241455078,230,2.32452164544878,0.747909980606364 +-147.74955,59.1579636,13.719616,355793.600357702,1034891.76085553,214.518920898438,230,2.33146560365075,0.773132418798921 +-147.68487,59.1548339,13.719616,359497.547001925,1034891.75444956,214.884979248047,230,2.33220605877818,0.775821963168676 +-147.6202,59.1516721,13.719616,363201.607734899,1034891.76166737,286.111267089844,330,2.45653496070144,1.2274200219556 +-147.55554,59.1484781,13.719616,366905.790496062,1034891.77139444,394.313446044922,430,2.59584158671955,1.73342144972309 +-147.4909,59.1452521,13.719616,370609.53243616,1034891.75011002,574.41357421875,430,2.75922469435862,2.32687553084993 +-139.98092,58.5423597,13.719616,807681.624858718,1034891.74163974,332.920440673828,241,2.52234046081999,1.46644438114588 +-139.91853,58.5353999,13.719616,811385.883230694,1034891.79453434,208.935852050781,241,2.32001296851959,0.731533179095047 +-139.85617,58.5284097,13.719616,815089.868882154,1034891.79624797,204.511535644531,241,2.31071780977842,0.697770509444656 +-139.79384,58.521389,13.719616,818793.589961857,1034891.73425984,210.471649169922,241,2.32319360402781,0.743086155104643 +-139.73153,58.5143379,13.719616,822497.61743559,1034891.74175786,216.669799804688,241,2.33579838205265,0.78887030665269 +-139.66924,58.5072563,13.719616,826201.959461256,1034891.80792471,262.896514892578,241,2.41978482888706,1.09393305367383 +-139.60698,58.5001444,13.719616,829906.049475669,1034891.82974207,262.603546142578,241,2.41930058641361,1.09217414679369 +-139.54475,58.4930021,13.719616,833609.895615123,1034891.79474261,270.166961669922,241,2.43163223868405,1.13696622764393 +-139.48254,58.4858295,13.719616,837314.068751039,1034891.83838022,197.450073242188,143,2.29545729916991,0.642339979131181 +-139.42036,58.4786265,13.719616,841018.009481694,1034891.82325255,182.76953125,143,2.26190379800124,0.520464085763825 +-139.35821,58.4713932,13.719616,844721.721099608,1034891.75875362,179.024291992188,143,2.25291196484787,0.487803181226087 +-139.29608,58.4641296,13.719616,848425.776851868,1034891.77113209,147.1328125,143,2.16770953675589,0.178323643201858 +-139.23398,58.4568357,13.719616,852129.614885762,1034891.7322572,82.5404205322266,40,1.9166666772184,-0.733535677404211 +-139.1719,58.4495116,13.719616,855833.805962375,1034891.78041572,68.6062774658203,40,1.83636385541573,-1.02521844689883 +-139.10985,58.4421572,13.719616,859537.790671503,1034891.77548408,84.9436264038086,40,1.92913079790195,-0.688262433467355 +-139.04783,58.4347726,13.719616,863241.572195257,1034891.72690005,85.9535675048828,40,1.93426390680005,-0.669617516814291 +-138.98583,58.4273578,13.719616,866945.723721219,1034891.7637562,76.7449188232422,40,1.88504963105374,-0.848377813477688 +-138.92386,58.4199128,13.719616,870649.683337117,1034891.75518811,80.9673385620117,40,1.9083098640282,-0.763890008182985 +-138.86191,58.4124376,13.719616,874354.024218835,1034891.8314285,95.4004135131836,40,1.97955025715802,-0.505124566302859 +-138.8,58.4049323,13.719616,878057.614359995,1034891.73918974,96.3299865722656,143,1.98376149974852,-0.489828131205865 +-138.73811,58.3973968,13.719616,881761.596986843,1034891.73005657,110.272850036621,143,2.04246859919736,-0.276587189333228 +-138.67624,58.3898312,13.719616,885465.975154974,1034891.81519217,77.4534378051758,40,1.88904069887616,-0.833881115982522 +-138.61441,58.3822356,13.719616,889169.616779575,1034891.73798453,93.2338256835938,40,1.96957350508522,-0.541362977479816 +-138.5526,58.3746098,13.719616,892873.667645027,1034891.74252773,118.639533996582,143,2.07422943216134,-0.161222778563797 +-138.49082,58.366954,13.719616,896577.560625851,1034891.71588081,126.454048156738,143,2.10193273691484,-0.0605964683886502 +-138.42906,58.3592682,13.719616,900281.868795917,1034891.79225104,129.773101806641,143,2.1131846851646,-0.0197261807197613 +-138.36733,58.3515524,13.719616,903986.030129098,1034891.83584919,131.699996948242,143,2.11958576489829,0.00352436792307645 +-138.30563,58.3438065,13.719616,907690.052756555,1034891.8344808,128.654602050781,143,2.10942532579326,-0.0333812469844563 +-138.24396,58.3360307,13.719616,911393.936964951,1034891.80855672,131.61198425293,143,2.11929543683072,0.00246981351377948 +-138.18232,58.3282249,13.719616,915097.690863375,1034891.74590386,134.380599975586,143,2.12833657577369,0.0353098107526203 +-138.1207,58.3203892,13.719616,918801.884849424,1034891.79443391,135.608169555664,143,2.13228585388259,0.0496547160803427 +-138.05911,58.3125236,13.719616,922505.956836862,1034891.81562071,133.189590454102,143,2.12447028350544,0.0212663336846362 +-137.99755,58.3046281,13.719616,926209.91228046,1034891.80818511,130.326187133789,143,2.11503168958069,-0.0130173334929879 +-137.93602,58.2967027,13.719616,929913.756628947,1034891.7708597,136.038711547852,143,2.13366250998291,0.0546551239734709 +-137.87451,58.2887474,13.719616,933618.06287203,1034891.84297037,152.645462036133,143,2.18368389778004,0.236347081978155 +-137.81304,58.2807623,13.719616,937321.698655719,1034891.75351079,164.739700317383,143,2.21679827161109,0.356627939515833 +-137.75159,58.2727474,13.719616,941025.804474526,1034891.78296188,172.009292602539,143,2.23555190979703,0.424746506228418 +-137.69017,58.2647026,13.719616,944729.820892441,1034891.77867504,168.095520019531,143,2.22555613903898,0.388439013758146 +-137.62878,58.2566281,13.719616,948433.747874603,1034891.76111226,169.932266235352,143,2.2302758492487,0.405582348379267 +-137.56742,58.2485239,13.719616,952137.590773229,1034891.72906012,139.648040771484,143,2.14503484703236,0.0959626981252091 +-137.50608,58.2403899,13.719616,955841.925228062,1034891.8144142,137.186218261719,143,2.13731048430426,0.0679056079441434 +-137.44478,58.2322261,13.719616,959545.62151505,1034891.72869319,129.482040405273,143,2.11220953448841,-0.023268206311404 +-137.3835,58.2240327,13.719616,963249.814558987,1034891.78079014,127.701232910156,143,2.106195090243,-0.0451143845040245 +-137.32225,58.2158096,13.719616,966953.944887199,1034891.81477848,124.0791015625,143,2.09369864015805,-0.090505058054509 +-137.26103,58.2075568,13.719616,970658.017821307,1034891.82950146,125.258125305176,143,2.09780590747937,-0.0755862908126739 +-137.19984,58.1992744,13.719616,974362.035880348,1034891.83463098,127.303848266602,143,2.10484153213511,-0.0500308938958241 +-137.13868,58.1909624,13.719616,978066.004343743,1034891.82902482,119.878036499023,143,2.0787396209551,-0.144840485528809 +-137.07755,58.1826208,13.719616,981769.92848475,1034891.81155189,156.469390869141,143,2.19442939187101,0.275377783585923 +-137.01645,58.1742496,13.719616,985473.813570442,1034891.78109221,185.994598388672,143,2.26950033172298,0.548056864507812 +-136.95538,58.1658488,13.719616,989177.664861689,1034891.73653683,192.864761352539,250,2.28525288421121,0.605274631371175 +-136.89433,58.1574186,13.719616,992882.049468058,1034891.84790149,198.875610351562,250,2.2985815255115,0.653688060946808 +-136.83332,58.1489588,13.719616,996585.843196413,1034891.79402716,155.928558349609,250,2.19292566360319,0.269915813310423 +-136.77234,58.1404695,13.719616,1000289.61597011,1034891.73358431,117.831977844238,150,2.07126316750248,-0.171997098461005 +-136.71138,58.1319507,13.719616,1003993.94054241,1034891.8166785,75.7236480712891,150,1.8792315284173,-0.869510822905065 +-136.65046,58.1234025,13.719616,1007697.68413368,1034891.75124104,96.5801162719727,150,1.98488772390804,-0.48573736360211 +-136.58956,58.1148248,10.81760087,1011401.98989755,1034891.82833693,341.699188232422,250,2.53364394705572,1.50750186949022 +-153.93111,59.2746847,13.719616,3913.67504331198,1031187.7749923,14.4745206832886,32,1.16060419118708,-3.47977042838836 +-153.86591,59.2746341,13.719616,7617.72697067354,1031187.77824896,21.8411159515381,32,1.33927482447288,-2.83078769061836 +-153.80071,59.2745509,13.719616,11321.7936014527,1031187.77321403,22.1164379119873,32,1.34471518051054,-2.81102676465735 +-153.73551,59.2744352,13.719616,15025.8820559156,1031187.77111316,24.1945457458496,32,1.38371747261439,-2.66935930737367 +-153.67031,59.274287,13.719616,18729.9994658289,1031187.77200927,26.7571182250977,32,1.42743933755872,-2.51054901443319 +-153.60512,59.2741063,13.719616,22433.5848580785,1031187.77260491,29.2999992370605,32,1.46686760904556,-2.36733427844386 +-153.53992,59.2738931,13.719616,26137.7815736463,1031187.77919664,29.2999992370605,32,1.46686760904556,-2.36733427844386 +-153.47472,59.2736473,13.719616,29842.0287274972,1031187.77790001,29.2999992370605,32,1.46686760904556,-2.36733427844386 +-153.40953,59.273369,13.719616,33545.7652794569,1031187.77497767,29.2999992370605,32,1.46686760904556,-2.36733427844386 +-153.34434,59.2730582,13.719616,37249.5664650862,1031187.77451669,35.481071472168,32,1.54999672636329,-2.06538559693353 +-153.27914,59.2727149,13.719616,40954.0075196508,1031187.78285276,40.2000007629395,32,1.60422606132677,-1.86840917375296 +-153.21395,59.272339,13.719616,44657.9594961791,1031187.77721716,50.2013854980469,32,1.70071570331739,-1.51793125315727 +-153.14876,59.2719306,13.719616,48361.9975188846,1031187.77460314,54.3843650817871,32,1.73547406266399,-1.39167897098695 +-153.08358,59.2714897,13.719616,52065.5606124813,1031187.76739275,57.0718078613281,32,1.75642162989543,-1.3155914277714 +-153.01839,59.2710163,13.719616,55769.7921155204,1031187.77094778,66.1597595214844,32,1.82059391796707,-1.08249936090063 +-152.95321,59.2705104,13.719616,59473.5629471012,1031187.76928799,75.3836288452148,32,1.8772770398464,-0.876610083261182 +-152.88802,59.269972,13.719616,63178.0164448542,1031187.78004144,89.3884353637695,32,1.95128133554562,-0.607805358352639 +-152.82284,59.2694011,13.719616,66882.0235268885,1031187.78503219,93.2994537353516,32,1.96987910097676,-0.540252965976009 +-152.75767,59.2687976,13.719616,70585.5915294187,1031187.7717189,92.9419021606445,32,1.96821155655923,-0.546309963265045 +-152.69249,59.2681616,13.719616,74289.8636012499,1031187.77230787,68.1451187133789,32,1.83343475244116,-1.03585778495169 +-152.62732,59.2674932,13.719616,77993.7104276966,1031187.7765078,72.3828353881836,32,1.85963559133537,-0.94068885962394 +-152.56215,59.2667922,13.719616,81697.7076899567,1031187.77295428,77.4719543457031,32,1.88914451183156,-0.833504037697323 +-152.49698,59.2660587,13.719616,85401.8622925106,1031187.77320648,84.9547653198242,32,1.92918774452419,-0.688055587081171 +-152.43182,59.2652928,13.719616,89105.6129905205,1031187.77542291,82.1240234375,32,1.91447021826675,-0.741513843248415 +-152.36666,59.2644943,13.719616,92809.5355288875,1031187.76996674,95.2380294799805,32,1.9788104010669,-0.507811934801761 +-152.3015,59.2636633,13.719616,96513.6367769974,1031187.7684493,88.6791534423828,32,1.94782153855773,-0.620372328537019 +-152.23634,59.2627999,13.719616,100217.923559571,1031187.78249848,98.9433364868164,32,1.99538655120081,-0.447602626211117 +-152.17119,59.2619039,13.719616,103921.835475431,1031187.77458187,90.539924621582,32,1.95684012859037,-0.587614235376601 +-152.10604,59.2609755,13.719616,107625.947144518,1031187.7820715,89.7413330078125,32,1.95299251620706,-0.60158986177071 +-152.0409,59.2600146,13.719616,111329.697877997,1031187.77753139,62.6833763122559,32,1.79715238081332,-1.16764571472387 +-151.06426,59.2417045,13.719616,166889.507411265,1031187.76415308,187.560760498047,33,2.27314198499364,0.561284388618153 +-150.86907,59.2371664,13.71823515,178001.518335083,1031187.75949644,45.181640625,33,1.65496199686872,-1.68412177438686 +-150.80401,59.2355889,13.719616,181706.006203626,1031187.78600334,240.727340698242,33,2.3815254182354,0.954963953863974 +-150.73897,59.233979,13.719616,185409.706431407,1031187.77629877,72.445915222168,33,1.86001390331328,-0.939314722539167 +-150.67393,59.2323366,13.719616,189113.762847925,1031187.77369338,84.9444808959961,33,1.9291351666744,-0.688246564838825 +-150.6089,59.2306618,13.719616,192817.613869312,1031187.76120865,121.110221862793,133,2.08318079971827,-0.128708856622337 +-150.54387,59.2289547,13.719616,196521.834075861,1031187.77883373,108.488731384277,133,2.03538463079487,-0.302318184536967 +-150.47885,59.2272151,13.719616,200225.863570509,1031187.77501139,116.888916015625,133,2.06777333116634,-0.184673180132324 +-150.41384,59.2254432,13.719616,203929.708232995,1031187.77133829,136.395156860352,133,2.13479894960076,0.0587829970376595 +-150.34883,59.2236389,13.719616,207633.943801761,1031187.78719877,140.646942138672,133,2.14813029443412,0.107206246617069 +-150.28383,59.2218022,13.719616,211338.009222445,1031187.79174517,133.917785644531,133,2.1268382595686,0.0298674986337003 +-150.21884,59.2199331,13.719616,215041.911543678,1031187.78429664,111.978218078613,133,2.04913355223931,-0.252378177517866 +-150.15386,59.2180316,13.719616,218745.657812299,1031187.7641897,123.953819274902,133,2.09325991282599,-0.0920986409497982 +-150.08888,59.2160978,13.719616,222449.822520035,1031187.77543482,153.59538269043,133,2.18637816034258,0.246133412624392 +-150.02391,59.2141316,13.719616,226153.845241507,1031187.77386066,158.154174804688,133,2.19908066049903,0.292272518847135 +-149.95895,59.2121331,13.719616,229857.732338125,1031187.77001508,156.710891723633,133,2.19509918186163,0.277810652008943 +-149.89399,59.2101022,13.719616,233562.059612064,1031187.78731213,159.517868041992,133,2.20280933665599,0.305816134919334 +-149.82905,59.208039,13.719616,237265.697189554,1031187.76655235,158.18180847168,133,2.1991565364648,0.292548122011981 +-149.76411,59.2059435,13.719616,240969.788282825,1031187.77806987,144.266906738281,133,2.15916672008003,0.147293694672527 +-149.69918,59.2038156,13.719616,244673.772511378,1031187.77499431,130.759613037109,133,2.11647362668275,-0.00777980636845699 +-149.63426,59.2016554,13.719616,248377.656172215,1031187.76795631,152.636947631836,133,2.18365967261221,0.236259089254071 +-149.56934,59.1994629,13.719616,252082.014366729,1031187.79440344,140.056640625,133,2.14630370522258,0.100571553240293 +-149.50444,59.197238,13.719616,255785.718636211,1031187.76733033,127.876502990723,133,2.10679075121086,-0.0429507738501798 +-149.43954,59.1949809,13.719616,259489.910681037,1031187.78504405,129.964050292969,133,2.11382323754888,-0.0174067761990554 +-149.37465,59.1926915,13.719616,263194.030132078,1031187.7979729,137.321319580078,133,2.13773796809767,0.0694583510978452 +-149.30978,59.1903697,13.719616,266897.51666162,1031187.75433436,137.021087646484,133,2.13678741054135,0.0660056547371502 +-149.24491,59.1880157,13.719616,270601.511898118,1031187.75582876,144.39892578125,133,2.1595639624233,0.148736592247509 +-149.18004,59.1856294,13.719616,274306.023603267,1031187.79256906,168.575698852539,133,2.22679496877681,0.392938796963168 +-149.11519,59.1832108,13.719616,278009.92254895,1031187.78211425,175.1845703125,133,2.24349585227023,0.453601172718017 +-149.05035,59.18076,13.719616,281713.782986543,1031187.77598657,169.992752075195,133,2.23043040490268,0.406143738629099 +-148.98552,59.1782769,13.719616,285417.612703512,1031187.76267936,179.025695800781,133,2.25291537032948,0.487815550907345 +-148.92069,59.1757615,13.719616,289121.986779019,1031187.78538873,187.139572143555,133,2.27216563221621,0.5577379966517 +-148.85588,59.173214,13.719616,292825.774245339,1031187.7795728,176.821701049805,133,2.24753556422808,0.468274559597521 +-148.79108,59.1706341,13.719616,296529.55273954,1031187.75446232,163.577590942383,133,2.2137238079132,0.345460609825787 +-148.72628,59.1680221,13.719616,300233.894705553,1031187.78841422,139.638565063477,133,2.14500537732192,0.0958556557254066 +-148.6615,59.1653778,13.719616,303937.672628782,1031187.76900568,137.523147583008,133,2.13837580377708,0.0717751523418627 +-148.59672,59.1627013,13.719616,307642.02877229,1031187.79810009,153.873519897461,133,2.18716388850017,0.248987401561928 +-148.53196,59.1599926,13.719616,311345.833853601,1031187.78336764,162.893005371094,133,2.21190243609515,0.338844867511361 +-148.46721,59.1572517,13.719616,315049.662901934,1031187.77035166,124.047676086426,133,2.09358863259617,-0.0909046369185425 +-148.40247,59.1544785,13.719616,318753.523780347,1031187.74770612,120.774337768555,133,2.08197466483584,-0.133089882780494 +-148.33773,59.1516733,13.719616,322457.988689296,1031187.79721706,126.100639343262,133,2.10071728849653,-0.065011323967482 +-148.27301,59.1488358,13.719616,326161.931159441,1031187.7887401,128.960250854492,133,2.11045586925487,-0.029638018985492 +-148.2083,59.1459662,13.719616,329865.924294533,1031187.79239434,128.550674438477,133,2.10907435950195,-0.0346560567302557 +-148.1436,59.1430644,13.719616,333569.975957843,1031187.7969021,130.823196411133,133,2.11668475606913,-0.00701292417480312 +-148.07892,59.1401304,13.719616,337273.52495311,1031187.7513559,156.568054199219,134,2.19470315427172,0.276372166764892 +-148.01424,59.1371643,13.719616,340977.713389278,1031187.767799,196.239654541016,134,2.29278677066988,0.632639857374339 +-147.94957,59.1341661,13.719616,344681.980031999,1031187.79591227,201.825622558594,134,2.30497630079794,0.676915710037741 +-147.88492,59.1311357,13.719616,348385.764672073,1031187.77203003,205.310424804688,230,2.31241100158787,0.703920665381626 +-147.82028,59.1280732,13.719616,352089.641272713,1031187.75857251,204.312774658203,230,2.31029552174806,0.696236638785374 +-147.75565,59.1249786,13.719616,355793.616695797,1031187.75549873,197.761077880859,230,2.29614082050234,0.64482272370696 +-147.69103,59.1218519,13.719616,359497.697800294,1031187.76278445,204.909912109375,330,2.31156296704095,0.700840361854076 +-147.62642,59.1186931,13.719616,363201.891442255,1031187.78042205,328.595153808594,430,2.51666115407864,1.44581551802575 +-147.56183,59.1155023,13.719616,366905.635287909,1031187.76429996,500.342559814453,430,2.69926744613032,2.1090936917823 +-139.93195,58.5029977,13.23920783,811385.569353187,1031187.72292099,310.109954833984,341,2.49151570774031,1.35448007970001 +-139.86964,58.4960139,13.719616,815089.883638249,1031187.79487108,241.974731445312,241,2.3837700165307,0.963116975544667 +-139.80736,58.4889996,13.719616,818793.929698322,1031187.80018833,206.074417114258,241,2.31402408010657,0.70977982698001 +-139.74511,58.481955,13.719616,822497.708572624,1031187.75912329,220.699661254883,241,2.34380166657693,0.817940520409724 +-139.68288,58.4748799,13.719616,826201.798879998,1031187.77266213,241.931640625,241,2.38369267055383,0.962836032879918 +-139.62068,58.4677745,13.719616,829905.633502686,1031187.73778005,414.258270263672,341,2.61727118744508,1.81125987617522 +-139.5585,58.4606388,13.719616,833609.786267038,1031187.77843725,479.344390869141,440,2.68064764976544,2.04146127676605 +-139.49635,58.4534727,13.719616,837313.697205422,1031187.75776691,463.326049804688,341,2.6658867184384,1.98784536099698 +-139.43422,58.4462763,13.719616,841017.937732006,1031187.81178427,194.790618896484,143,2.28956803745227,0.62094849961006 +-139.37212,58.4390496,13.719616,844721.945446525,1031187.81344189,186.833618164062,143,2.27145502430046,0.555156865874018 +-139.31005,58.4317926,13.719616,848425.726047717,1031187.76122769,173.953918457031,143,2.24043421603905,0.442480436048382 +-139.248,58.4245054,13.719616,852129.850871393,1031187.79285378,147.50520324707,143,2.16880734032526,0.182311179110158 +-139.18598,58.4171879,13.719616,855833.759941586,1031187.76873217,81.0399017333984,143,1.90869890573983,-0.762476897642806 +-139.12398,58.4098402,13.719616,859538.024562212,1031187.8277107,94.0292434692383,40,1.97326294192096,-0.527961889822296 +-139.06202,58.4024623,13.719616,863241.514168888,1031187.71002397,84.315185546875,40,1.92590580007293,-0.699976546088366 +-139.00007,58.3950542,13.719616,866945.938715199,1031187.80416898,82.5524749755859,40,1.91673009821816,-0.733305314230949 +-138.93816,58.387616,13.719616,870649.597007686,1031187.72963559,96.5805282592773,143,1.9848895764988,-0.485730634463671 +-138.87627,58.3801476,13.719616,874353.633375927,1031187.7357408,102.934837341309,143,2.01256238258127,-0.385215104166934 +-138.8144,58.3726491,13.719616,878058.05090877,1031187.83362133,110.398277282715,143,2.04296229646883,-0.274793939928017 +-138.75257,58.3651205,13.719616,881761.718982262,1031187.75798864,100.783302307129,143,2.00338858452448,-0.418536957171833 +-138.69076,58.3575618,13.719616,885465.779385588,1031187.77242879,69.0143051147461,40,1.83893911955585,-1.01586435248832 +-138.62898,58.349973,13.719616,889169.669587791,1031187.74333536,70.9883270263672,40,1.8511869413273,-0.971376767938039 +-138.56722,58.3423542,13.719616,892873.960688125,1031187.8146501,68.4942016601562,40,1.83565380808245,-1.02779754148097 +-138.5055,58.3347054,13.719616,896577.522008772,1031187.71666361,116.10954284668,40,2.0648679151334,-0.195226480452253 +-138.44379,58.3270265,13.719616,900282.065983308,1031187.84215793,129.938079833984,143,2.11373644466987,-0.0177220327087642 +-138.38212,58.3193176,13.719616,903985.891243929,1031187.79564398,132.132919311523,143,2.12101103028881,0.00870133863268742 +-138.32048,58.3115788,13.719616,907689.568795547,1031187.72165196,135.227722167969,143,2.13106573265896,0.0452228875388341 +-138.25886,58.30381,13.719616,911393.674844411,1031187.745222,131.683563232422,143,2.11953156962428,0.00332751521899174 +-138.19727,58.2960113,13.719616,915097.644153873,1031187.739779,134.626113891602,143,2.12912930965775,0.0381892464883032 +-138.1357,58.2881827,13.719616,918802.050294474,1031187.84236366,133.720748901367,143,2.12619880018811,0.0275447996438751 +-138.07417,58.2803241,13.719616,922505.765170429,1031187.76468009,137.537582397461,143,2.13842138614916,0.0719407205277808 +-138.01266,58.2724357,13.719616,926209.925147234,1031187.80441137,134.71809387207,143,2.1294259293612,0.0392666539149145 +-137.95118,58.2645175,13.719616,929913.9675378,1031187.82192438,134.505889892578,143,2.12874130212162,0.0367798923686959 +-137.88973,58.2565694,13.719616,933617.900437798,1031187.80510199,137.184173583984,143,2.13730401135905,0.0678820963595651 +-137.82831,58.2485915,13.719616,937321.726588894,1031187.76353645,164.252304077148,143,2.2155114704143,0.351953910279471 +-137.76691,58.2405838,13.719616,941026.01949542,1031187.83767733,168.000228881836,143,2.22530987340474,0.387544506683377 +-137.70555,58.2325463,13.719616,944729.648341401,1031187.74345194,163.225799560547,143,2.21278880467048,0.342064411171752 +-137.64421,58.224479,13.719616,948433.754723785,1031187.76358777,167.898101806641,143,2.22504578619426,0.386585266556946 +-137.5829,58.216382,13.719616,952137.773185164,1031187.76600802,145.372253417969,143,2.16248152249703,0.159334003189866 +-137.52162,58.2082553,13.719616,955841.709070845,1031187.74950321,135.050933837891,143,2.13049759155376,0.0431592368811352 +-137.46037,58.2000989,13.719616,959545.567720033,1031187.71287524,135.205032348633,143,2.13099285640273,0.044958180175239 +-137.39914,58.1919129,13.719616,963249.919806667,1031187.81080658,128.180053710938,143,2.10782044922932,-0.0392106167420778 +-137.33795,58.1836971,13.719616,966953.639966085,1031187.7309383,131.099517822266,143,2.11760109437876,-0.00368452188523158 +-137.27678,58.1754518,13.719616,970657.861407021,1031187.79522023,128.453811645508,143,2.10874699573394,-0.0358451353745881 +-137.21564,58.1671768,13.719616,974362.026867257,1031187.8358044,123.050796508789,143,2.09008442923957,-0.103632903708934 +-137.15454,58.1588722,13.719616,978065.570746861,1031187.71508951,127.022438049316,143,2.10388044426515,-0.0535218393613094 +-137.09346,58.1505381,13.719616,981769.631714252,1031187.73674077,168.103240966797,143,2.22557608655326,0.388511468823605 +-137.03241,58.1421744,13.719616,985473.649724808,1031187.74209603,230.081604003906,240,2.36188189637845,0.883613075660216 +-136.97139,58.1337811,13.719616,989177.630038729,1031187.73003872,249.967651367188,250,2.39788380970513,1.01438230083182 +-136.9104,58.1253584,13.719616,992881.572223251,1031187.72107234,241.72331237793,250,2.38331853683242,0.961477072415362 +-136.84943,58.1169061,13.719616,996586.055278007,1031187.8425459,231.785400390625,250,2.36508607731579,0.895251575388902 +-136.7885,58.1084244,13.719616,1000289.94250873,1031187.81540527,156.717529296875,250,2.19511757624605,0.277877465663448 +-136.7276,58.0999132,13.719616,1003993.81006917,1031187.7772707,150.768920898438,250,2.17831182645827,0.216834185595688 +-136.66673,58.0913726,13.719616,1007697.66027583,1031187.73786594,266.501281738281,250,2.42569930210752,1.11541610856927 +-136.60588,58.0828026,13.719616,1011402.06639701,1031187.84841791,230.861419677734,150,2.3633513620163,0.888950594284104 +-154.06145,59.2415589,13.719616,-3494.43200224493,1027483.77679984,11.9134511947632,32,1.07603759000694,-3.78694046158572 +-153.99631,59.2415733,13.719616,209.836459311778,1027483.77589383,16.2930698394775,32,1.21200291909915,-3.29307557795418 +-153.93118,59.2415552,13.719616,3913.53666414009,1027483.77418139,18.3707733154297,32,1.26412743826308,-3.10374444653181 +-153.86604,59.2415046,13.719616,7617.81306552251,1027483.77229322,15.4541883468628,32,1.18904620087554,-3.37646093104207 +-153.80091,59.2414216,13.719616,11321.5354332209,1027483.77970067,24.3560523986816,32,1.38660689970806,-2.65886408344485 +-153.73577,59.241306,13.719616,15025.8482764805,1027483.77694021,27.3999996185303,32,1.43775055677403,-2.4730957231282 +-153.67064,59.2411579,13.719616,18729.6213758714,1027483.77128755,29.4422225952148,32,1.46897059182044,-2.35969564475447 +-153.6055,59.2409774,13.719616,22433.9991179331,1027483.77908599,31.1062755584717,32,1.49284801492631,-2.27296602873887 +-153.54037,59.2407643,13.719616,26137.8514273576,1027483.77187507,32.9000015258789,32,1.51719591809225,-2.18452749485674 +-153.47524,59.2405188,13.719616,29841.7539504626,1027483.77495086,32.9000015258789,32,1.51719591809225,-2.18452749485674 +-153.41011,59.2402408,13.719616,33545.713881062,1027483.7772666,36.5999984741211,32,1.56348106728838,-2.01640662187954 +-153.34498,59.2399303,13.719616,37249.7383462925,1027483.77897325,42.0999984741211,32,1.62428208009503,-1.79555998902895 +-153.27985,59.2395873,13.719616,40953.834473008,1027483.78023945,40.2000007629395,32,1.60422606132677,-1.86840917375296 +-153.21472,59.2392118,13.719616,44658.0093877484,1027483.78125141,49.4000015258789,32,1.69372696233824,-1.54331635517883 +-153.1496,59.2388038,13.719616,48361.7015542044,1027483.77493084,56.3007049560547,32,1.75051383280175,-1.33705023306882 +-153.08447,59.2383633,13.719616,52066.0554231585,1027483.77550594,64.9981155395508,32,1.81290076552534,-1.1104430864133 +-153.01935,59.2378904,13.719616,55769.9406299366,1027483.77927275,70.2228622436523,32,1.84647852708448,-0.988479072383188 +-152.95423,59.237385,13.719616,59473.9331051322,1027483.78259089,87.011962890625,32,1.93957896595451,-0.650311704896394 +-152.88911,59.236847,13.719616,63178.040160224,1027483.77455608,102.315811157227,32,2.00994275167642,-0.394730351330461 +-152.824,59.2362767,13.719616,66881.6996956517,1027483.77892547,110.800605773926,32,2.04454213479272,-0.269055516204904 +-152.75888,59.2356738,13.719616,70586.0567208438,1027483.78205672,112.748428344727,32,2.05211049674982,-0.241565065351137 +-152.69377,59.2350384,13.719616,74289.9808466552,1027483.77475625,86.2334060668945,32,1.93567554030269,-0.664490061012391 +-152.62866,59.2343706,13.719616,77994.047626974,1027483.77861768,69.7675170898438,32,1.84365326743425,-0.998741221842227 +-152.56356,59.2336703,13.719616,81697.6957298432,1027483.77052334,72.3437728881836,32,1.85940115443654,-0.941540401355445 +-152.49845,59.2329376,13.719616,85402.0693484292,1027483.78607664,85.7397766113281,32,1.93318234765381,-0.673546048341162 +-152.43335,59.2321723,13.719616,89106.0387725578,1027483.77815882,92.6946868896484,32,1.96705484179675,-0.550511481441614 +-152.36826,59.2313746,13.719616,92809.6106052642,1027483.76786643,93.8501663208008,32,1.97243504661258,-0.530969041887182 +-152.30316,59.2305445,13.719616,96513.9292574175,1027483.78302388,99.9758605957031,32,1.99989515124373,-0.431226103972649 +-152.23807,59.2296818,13.719616,100217.865082299,1027483.77322036,109.020706176758,32,2.03750899082391,-0.294601902558767 +-152.17298,59.2287868,13.719616,103921.992969786,1027483.78642778,114.641494750977,32,2.05934183996665,-0.215298762756766 +-152.1079,59.2278592,13.719616,107625.752263422,1027483.77339687,92.3566665649414,32,1.96546824950957,-0.556274437487188 +-152.04282,59.2268992,13.719616,111329.718115061,1027483.77207299,83.0326614379883,32,1.91924895854601,-0.724156094565869 +-151.97774,59.2259068,13.719616,115033.89760633,1027483.78297588,30.023120880127,33,1.4774558348283,-2.32887482022043 +-151.45728,59.2167993,11.62721023,144665.646237439,1027483.77414115,31.1016311645508,33,1.49278316674988,-2.27320157582519 +-151.39224,59.2155149,13.63193595,148369.794305453,1027483.77727953,49.4011306762695,33,1.69373688902173,-1.54328029863104 +-151.26218,59.2128489,8.623464667,155777.813644462,1027483.77913996,18.1349906921387,33,1.25851733701301,-3.12412193555436 +-151.06713,59.2086068,13.71004772,166889.825839214,1027483.77906237,128.706954956055,33,2.10960201557125,-0.0327394592785097 +-150.93713,59.2056167,13.42166039,174297.525961594,1027483.76183438,41.7773361206055,33,1.62094074428467,-1.80769667440439 +-150.87213,59.2040731,13.719616,178001.873161898,1027483.78062298,84.3259506225586,33,1.92596124577354,-0.699775151477985 +-150.80714,59.2024971,13.719616,181705.99270387,1027483.78770248,123.175590515137,133,2.09052465299972,-0.102033885359696 +-150.74216,59.2008887,13.719616,185409.891645801,1027483.78225119,84.212516784668,33,1.92537664692138,-0.701898581370159 +-150.67719,59.1992479,13.719616,189113.577044442,1027483.76346476,117.833236694336,33,2.0712678072339,-0.171980245632154 +-150.61222,59.1975748,13.719616,192817.624047391,1027483.77075573,96.5064926147461,133,1.98455653212001,-0.48694034670777 +-150.54725,59.1958693,13.719616,196522.040256459,1027483.79386111,115.211647033691,133,2.06149638522243,-0.207472839419346 +-150.4823,59.1941314,13.719616,200225.695398614,1027483.77340288,144.412628173828,133,2.15960517180989,0.148886276501951 +-150.41735,59.1923611,13.719616,203929.733849125,1027483.76838735,165.596160888672,133,2.21905026406606,0.364807818894918 +-150.35241,59.1905585,13.719616,207633.593380347,1027483.75966837,185.995162963867,133,2.26950164999525,0.548061652848937 +-150.28747,59.1887236,13.719616,211337.849668895,1027483.77836649,150.434356689453,133,2.17734703317498,0.213329781011371 +-150.22254,59.1868563,13.719616,215041.941700229,1027483.7819278,117.213073730469,133,2.06897605479078,-0.180304544636854 +-150.15762,59.1849567,13.719616,218745.875871198,1027483.7808479,127.047065734863,133,2.10396463908436,-0.0532160197463565 +-150.09271,59.1830247,13.719616,222449.659847982,1027483.76331585,126.354034423828,133,2.10158911329221,-0.0618446074659937 +-150.0278,59.1810605,13.719616,226153.867996143,1027483.78507406,138.553436279297,133,2.14161730123792,0.0835491963351464 +-149.9629,59.1790639,13.719616,229857.939983956,1027483.790248,146.036529541016,133,2.16446150368679,0.166525860013961 +-149.89801,59.1770349,13.719616,233561.882847313,1027483.77824104,136.005645751953,133,2.1335569368116,0.0542716520816754 +-149.83313,59.1749737,13.719616,237265.702218142,1027483.77078964,130.367889404297,133,2.1151706345568,-0.0125126456808957 +-149.76825,59.1728802,13.719616,240969.974437421,1027483.79245488,131.567321777344,133,2.11914803415554,0.00193440492458937 +-149.70339,59.1707543,13.719616,244673.56990026,1027483.75952174,147.396347045898,133,2.16848672044659,0.181146596196809 +-149.63853,59.1685962,13.719616,248377.631492201,1027483.76690097,166.547546386719,133,2.2215382389572,0.373844853838274 +-149.57368,59.1664058,13.719616,252081.598255867,1027483.76663806,165.454559326172,133,2.21867873923788,0.363458334675232 +-149.50883,59.1641831,13.719616,255786.045844883,1027483.79675293,155.09619140625,133,2.19060113326455,0.261472455633486 +-149.444,59.1619281,13.719616,259489.843923284,1027483.78029376,131.704345703125,133,2.11960010513452,0.00357645575417648 +-149.37918,59.1596408,13.719616,263193.568140426,1027483.75475707,150.376953125,133,2.1771812810854,0.212727722111644 +-149.31436,59.1573213,13.719616,266897.793355361,1027483.77103935,136.80436706543,133,2.13609996114248,0.0635086423028391 +-149.24955,59.1549696,13.719616,270601.957855439,1027483.78963785,140.245529174805,133,2.14688902546716,0.102697603435649 +-149.18475,59.1525856,13.719616,274306.069398181,1027483.7989897,158.644332885742,133,2.20042456278746,0.297153955546614 +-149.11997,59.1501693,13.719616,278009.566299097,1027483.75683989,173.177932739258,133,2.23849255107539,0.435427754694026 +-149.05519,59.1477208,13.719616,281713.592027216,1027483.75712746,170.373382568359,133,2.2314017459082,0.40967192640948 +-148.99042,59.1452401,13.719616,285417.584860805,1027483.75818678,172.737976074219,133,2.23738782677644,0.431415080720521 +-148.92566,59.1427272,13.719616,289121.551738276,1027483.75967344,181.773025512695,133,2.25952943587072,0.511839724795366 +-148.8609,59.140182,13.719616,292826.069122415,1027483.79420664,162.227569580078,133,2.21012466182978,0.332387483952234 +-148.79616,59.1376047,13.719616,296530.004904225,1027483.79614114,149.919250488281,133,2.1758574023216,0.207919016568912 +-148.73143,59.1349951,13.719616,300233.936416769,1027483.78642693,150.831756591797,133,2.17849278888524,0.217491492782266 +-148.66671,59.1323534,13.719616,303937.868827674,1027483.78707728,152.304748535156,133,2.18271344391691,0.23282211655218 +-148.602,59.1296794,13.719616,307641.810846001,1027483.77554435,180.625595092773,133,2.25677929093845,0.501850413431841 +-148.5373,59.1269733,13.719616,311345.767590923,1027483.77387168,186.628387451172,133,2.27097770358908,0.553423100809375 +-148.47261,59.124235,13.719616,315049.746880436,1027483.77068969,171.080078125,133,2.23319943990865,0.416201664132066 +-148.40793,59.1214646,13.719616,318753.754692867,1027483.77692931,138.676284790039,133,2.14200219816464,0.0849472518335137 +-148.34326,59.118662,13.719616,322457.798862734,1027483.78125644,128.652297973633,133,2.10941754793739,-0.0334094983770005 +-148.2786,59.1158272,13.719616,326161.886303361,1027483.7834957,127.045257568359,133,2.10395845804965,-0.0532384710286673 +-148.21395,59.1129603,13.719616,329866.022952614,1027483.79462565,133.419677734375,133,2.12521988731078,0.0239891086638675 +-148.14932,59.1100613,13.719616,333569.647023431,1027483.76427357,139.705612182617,133,2.14521385272109,0.0966128978800178 +-148.08469,59.1071301,13.719616,337273.903707962,1027483.78107473,144.5,134,2.15986784709257,0.149840388103618 +-148.02008,59.1041669,13.719616,340977.660573108,1027483.76617545,169.738311767578,134,2.22977987833038,0.403780840439734 +-147.95547,59.1011715,13.719616,344682.06381078,1027483.79934119,186.916152954102,134,2.27164683394013,0.555853573233206 +-147.89088,59.098144,13.719616,348385.981965908,1027483.78838457,215.962066650391,134,2.33437747480294,0.783709165954435 +-147.8263,59.0950845,13.719616,352089.989524753,1027483.79571923,234.212707519531,230,2.36961045459584,0.911685405055887 +-147.76174,59.0919928,13.719616,355793.526748208,1027483.74546287,235.132080078125,330,2.37131188582613,0.91786548892114 +-147.69718,59.0888691,13.719616,359497.73573068,1027483.76644025,219.769226074219,330,2.34196687879791,0.811276047495744 +-147.63263,59.0857134,13.719616,363202.054630081,1027483.80562036,427.302612304688,430,2.63073554787463,1.86016627636643 +-147.5681,59.0825255,13.719616,366905.923763455,1027483.78550374,642.689697265625,430,2.80800133794284,2.50404622258796 +-139.82086,58.4566082,12.75824452,818793.962856631,1027483.81678095,523.587524414062,440,2.71898929001264,2.18072905793755 +-139.75866,58.4495699,13.719616,822498.060385612,1027483.82920028,223.980621337891,241,2.35021044507485,0.841219033161662 +-139.69649,58.4425014,13.719616,826201.890443983,1027483.80162304,293.877868652344,341,2.46816688146537,1.26967047825093 +-139.44806,58.4139238,13.719616,841017.531969567,1027483.7184269,210.92170715332,241,2.32412127775646,0.746455730871544 +-139.38601,58.4067037,13.719616,844721.830776895,1027483.78626559,204.365478515625,143,2.31040753649023,0.696643508301131 +-139.32399,58.3994533,13.719616,848425.898771903,1027483.79723385,192.575057983398,143,2.28460003729718,0.602903305038355 +-139.262,58.3921727,13.719616,852129.739186673,1027483.76072563,174.017654418945,143,2.24059331051127,0.443058312581577 +-139.20003,58.3848619,13.719616,855833.926339089,1027483.80410895,149.345397949219,143,2.1741918444423,0.201869234953737 +-139.13809,58.3775209,13.719616,859537.897216302,1027483.79814135,92.4934768676758,40,1.96611110506045,-0.553939402637131 +-139.07618,58.3701497,13.719616,863241.657462179,1027483.74134643,83.82275390625,40,1.92336192500941,-0.7092166264133 +-139.01429,58.3627484,13.719616,866945.778877112,1027483.77369362,73.0253295898438,40,1.86347352577879,-0.926748386269876 +-138.95243,58.3553169,13.719616,870649.700910749,1027483.75340847,87.3589401245117,40,1.94130735634889,-0.644033697652253 +-138.89059,58.3478553,13.719616,874353.995331597,1027483.82159565,108.574501037598,143,2.03572784220543,-0.301071542731515 +-138.82879,58.3403636,13.719616,878057.530404879,1027483.71406277,119.524276733398,143,2.07745612436829,-0.149502511478486 +-138.767,58.3328418,13.719616,881762.017702444,1027483.82603441,123.941787719727,143,2.09321775606421,-0.0922517663413342 +-138.70525,58.32529,13.719616,885465.754264578,1027483.7703327,78.7665634155273,40,1.89634189761822,-0.807361078181762 +-138.64352,58.3177081,13.719616,889169.885519442,1027483.80078022,77.06640625,40,1.88686510749796,-0.841783484843734 +-138.58182,58.3100962,13.719616,892873.845800366,1027483.79409186,70.765510559082,40,1.84982164436514,-0.976335916199157 +-138.52015,58.3024542,13.719616,896577.643218926,1027483.73801477,100.051567077637,40,2.0002238952495,-0.430032011910832 +-138.4585,58.2947823,13.719616,900281.846810349,1027483.78848758,71.1890716552734,40,1.85241332953455,-0.96692217592329 +-138.39688,58.2870804,13.719616,903985.896001819,1027483.79883234,124.684173583984,143,2.09581133109404,-0.0828311615529915 +-138.33529,58.2793486,13.719616,907689.793694939,1027483.77856798,135.059280395508,143,2.13052443144153,0.0432567270143667 +-138.27373,58.2715868,13.719616,911393.547987658,1027483.71549182,140.467025756836,143,2.14757438678507,0.105187031363878 +-138.21219,58.2637951,13.719616,915097.730412049,1027483.75693449,131.86701965332,143,2.12013619074302,0.00552367169830586 +-138.15068,58.2559736,13.719616,918801.775129018,1027483.77575798,139.62141418457,143,2.14495203253475,0.0956618922323104 +-138.0892,58.2481221,13.719616,922505.69287005,1027483.74894066,137.619735717773,143,2.13868071950062,0.0728826932813688 +-138.02774,58.2402408,13.719616,926210.052457686,1027483.83636593,139.847137451172,143,2.14565358116959,0.0982101171159366 +-137.96632,58.2323297,13.719616,929913.721983669,1027483.75836934,138.241180419922,143,2.14063743352363,0.0799900371147506 +-137.90492,58.2243888,13.719616,933617.844183691,1027483.79316296,132.760620117188,143,2.12306927230574,0.0161774611189291 +-137.84355,58.216418,13.719616,937321.858491441,1027483.7891699,147.051849365234,143,2.16747049068645,0.177455359647114 +-137.78221,58.2084175,13.719616,941025.764932675,1027483.76682591,154.264572143555,143,2.18826619897834,0.252991307849365 +-137.7209,58.2003873,13.719616,944729.568870021,1027483.72487987,153.696258544922,143,2.1866632955214,0.247169104979552 +-137.65961,58.1923273,13.719616,948433.847044013,1027483.79406825,167.685516357422,143,2.22449555254231,0.384586660880744 +-137.59835,58.1842375,13.719616,952138.036172652,1027483.8314733,148.924606323242,143,2.1729664607308,0.197418291554228 +-137.53713,58.1761181,13.719616,955841.567485063,1027483.71362026,147.491470336914,143,2.16876690510927,0.182164306864341 +-137.47593,58.1679691,13.719616,959545.583614704,1027483.72659429,139.760055541992,143,2.14538306456772,0.0972275236048284 +-137.41476,58.1597903,13.719616,963249.526724113,1027483.70417081,131.485900878906,143,2.11887918629521,0.000957872759044863 +-137.35361,58.151582,13.719616,966953.962518057,1027483.82324629,137.109130859375,143,2.1370663778369,0.0670189435797704 +-137.2925,58.143344,13.719616,970657.764494323,1027483.77034672,126.910736083984,143,2.10349836303093,-0.0549096674608184 +-137.23141,58.1350764,13.719616,974362.072500673,1027483.84689011,124.168815612793,143,2.09401253861191,-0.0893648892745509 +-137.17036,58.1267793,13.719616,978065.751689043,1027483.76965882,121.288314819336,143,2.08381896200479,-0.126390869048036 +-137.10933,58.1184526,13.719616,981769.947437419,1027483.8206772,166.431564331055,143,2.22123569524085,0.372745928705916 +-137.04834,58.1100963,13.719616,985473.527686487,1027483.70370329,270.524017333984,240,2.43220582815825,1.13904966833296 +-136.98737,58.1017106,13.719616,989177.629359125,1027483.73545043,305.465423583984,250,2.48496205845249,1.33067535488893 +-136.92643,58.0932953,13.719616,992881.694668093,1027483.74534746,307.473022460938,250,2.48780701698844,1.34100905632348 +-136.86552,58.0848506,13.719616,996585.723159331,1027483.75389668,307.736022949219,350,2.48817833684665,1.34235779603375 +-136.80464,58.0763765,13.719616,1000289.72001439,1027483.75999078,300.648590087891,350,2.47805917153264,1.30560209931593 +-136.74379,58.0678729,13.719616,1003993.69327898,1027483.75173645,242.231628417969,250,2.38423084875993,0.964790849735831 +-136.68297,58.0593399,13.719616,1007697.64527171,1027483.73885023,237.527099609375,250,2.37571316570577,0.933852193694324 +-136.62218,58.0507775,13.719616,1011401.58115554,1027483.72025723,122.894798278809,150,2.0895335010588,-0.105634032112056 +-154.06139,59.2084289,12.486833,-3494.44397879642,1023779.78008059,12.1261672973633,32,1.0837235556374,-3.75902284062286 +-153.99631,59.2084433,13.719616,210.042264539208,1023779.78072722,14.5186471939087,32,1.16192615192942,-3.47496868964702 +-153.93124,59.2084252,13.719616,3913.9596932019,1023779.77749297,11.9460515975952,32,1.07722438622743,-3.7826296789675 +-153.86617,59.2083747,13.719616,7617.88462951591,1023779.78104156,14.8114166259766,32,1.1705965982526,-3.44347515380946 +-153.8011,59.2082917,13.719616,11321.8241986966,1023779.7802203,18.5748329162598,32,1.26892491589841,-3.08631863842383 +-153.73603,59.2081762,13.719616,15025.7855252689,1023779.77507421,23.7356662750244,32,1.37540142714371,-2.69956555815889 +-153.67096,59.2080283,13.719616,18729.7756782728,1023779.77684589,32.4229850769043,32,1.51085299640849,-2.20756679686225 +-153.60589,59.2078479,13.719616,22433.8018154968,1023779.77443552,34.7000007629395,32,1.54032948433959,-2.10049977926921 +-153.54082,59.2076351,13.719616,26137.8709837804,1023779.77912077,34.7000007629395,32,1.54032948433959,-2.10049977926921 +-153.47575,59.2073898,13.719616,29841.9903624698,1023779.77983712,36.5999984741211,32,1.56348106728838,-2.01640662187954 +-153.41069,59.207112,13.719616,33545.5978550667,1023779.77166636,38.4000015258789,32,1.58433124162484,-1.94067283745725 +-153.34562,59.2068018,13.719616,37249.8389153364,1023779.77548346,36.5999984741211,32,1.56348106728838,-2.01640662187954 +-153.28056,59.2064591,13.719616,40953.5823142678,1023779.76961671,44.9496536254883,32,1.65272634948151,-1.69224228381447 +-153.21549,59.206084,13.719616,44657.9734831226,1023779.77720694,53.1155967712402,32,1.72522206528288,-1.42891715168652 +-153.15043,59.2056764,13.719616,48361.8812141199,1023779.77438689,63.842399597168,32,1.8051092021557,-1.13874426850544 +-153.08537,59.2052364,13.719616,52065.8816956622,1023779.77872333,71.4624862670898,32,1.85407812176418,-0.960875175366231 +-153.02031,59.2047639,13.719616,55769.9821815412,1023779.7792756,78.0698852539062,32,1.89248354104482,-0.821375730540937 +-152.95526,59.204259,13.719616,59473.6203969384,1023779.77852318,103.403343200684,32,2.01453458044203,-0.378051518615327 +-152.8902,59.2037216,13.719616,63177.9420570896,1023779.78291392,124.710777282715,32,2.09590398605405,-0.0824946122918452 +-152.82515,59.2031517,13.719616,66881.8158418359,1023779.77427067,126.861022949219,132,2.10332820902747,-0.0555277153681939 +-152.7601,59.2025494,13.719616,70585.8178824469,1023779.77303594,124.002502441406,32,2.09343044956165,-0.0914792028498501 +-152.69505,59.2019147,13.719616,74289.9552652632,1023779.77953567,116.561027526855,32,2.06655336723891,-0.189104437329108 +-152.63001,59.2012475,13.719616,77993.6660864182,1023779.77119155,102.039031982422,32,2.00876632991926,-0.39900345093664 +-152.56497,59.2005479,13.719616,81697.5264425326,1023779.77017136,81.0997467041016,32,1.90901949779707,-0.761312415784832 +-152.49993,59.1998158,13.719616,85401.543670562,1023779.76567641,77.667839050293,32,1.89024122196168,-0.829520473472495 +-152.43489,59.1990513,13.719616,89105.7246236484,1023779.76928049,86.4582901000977,32,1.93680664216877,-0.660381576186172 +-152.36986,59.1982544,13.719616,92809.50716459,1023779.76742214,97.8171463012695,32,1.99041498864587,-0.465660760435895 +-152.30482,59.197425,13.719616,96514.0371014612,1023779.77674844,113.822326660156,32,2.05622745884514,-0.226611083922976 +-152.2398,59.1965633,13.719616,100217.613295318,1023779.7764627,118.230751037598,32,2.07273044836433,-0.16666751556711 +-152.17477,59.195669,13.719616,103921.951376371,1023779.77710114,129.586181640625,32,2.11255869322297,-0.0219999621276359 +-152.10975,59.1947424,13.719616,107625.919095116,1023779.78193689,99.8739852905273,32,1.99945237995696,-0.432834375665722 +-152.04474,59.1937833,13.719616,111329.524155883,1023779.76744661,96.4702301025391,32,1.98439331441256,-0.48753320000821 +-151.97972,59.1927918,13.719616,115033.91176992,1023779.77829447,102.577522277832,33,2.0110522046336,-0.390700501520551 +-151.91471,59.1917679,13.719616,118737.950573838,1023779.7809314,46.1032905578613,33,1.66373192365692,-1.65226689710577 +-151.84971,59.1907116,13.10019312,122441.647643738,1023779.77423776,33.8163185119629,33,1.52912632540934,-2.1411928502038 +-151.78471,59.1896228,11.43964713,126145.5796478,1023779.76493235,65.2015686035156,33,1.81425804400886,-1.10551306355531 +-151.58973,59.1861622,7.334944777,137257.714642351,1023779.77537471,49.7522087097168,33,1.69681236566767,-1.53210928962455 +-151.52475,59.1849438,12.19707151,140961.517246426,1023779.76281277,28.9562091827393,33,1.46174170535734,-2.38595302371808 +-151.45977,59.1836931,13.719616,144665.589365388,1023779.77087171,45.7489166259766,33,1.66038081405425,-1.6644390836846 +-151.39479,59.1824099,13.719616,148369.938911753,1023779.77788335,99.9938735961914,33,1.99997339255127,-0.430941909211374 +-151.32982,59.1810944,13.719616,152074.002866468,1023779.78398515,24.541784286499,33,1.38990613449574,-2.64688032100067 +-151.26486,59.1797465,13.719616,155777.788722978,1023779.77704274,65.9459533691406,33,1.81918815115802,-1.08760550719689 +-151.1999,59.1783662,13.719616,159481.872766132,1023779.78012529,28.7964363098145,33,1.45933874516389,-2.39468126101379 +-151.13495,59.1769535,13.719616,163185.692839007,1023779.76940615,53.7422714233398,33,1.73031601799175,-1.41041446148906 +-151.07,59.1755085,13.719616,166889.824730693,1023779.78027381,93.8370056152344,33,1.97237414077916,-0.531190269258431 +-151.00506,59.1740311,13.719616,170593.706752781,1023779.77665093,58.2749443054199,33,1.76548186712852,-1.28268206009167 +-150.94012,59.1725213,13.719616,174297.91518466,1023779.78390718,52.7388877868652,33,1.72213096669518,-1.44014490404443 +-150.87519,59.1709791,13.719616,178001.887863824,1023779.77605451,79.4030151367188,33,1.89983699401875,-0.794665890455197 +-150.81027,59.1694046,13.719616,181705.631309751,1023779.76341902,180.152099609375,133,2.25563932803756,0.497709742798014 +-150.74535,59.1677978,13.719616,185409.721764663,1023779.7730941,129.361312866211,133,2.11180441450238,-0.0247397177334203 +-150.68044,59.1661586,13.719616,189113.597587387,1023779.766303,135.306259155273,33,2.13131788716467,0.046138784675654 +-150.61553,59.1644871,13.719616,192817.83448029,1023779.78245616,104.388168334961,133,2.01865127722918,-0.363098500862162 +-150.55063,59.1627832,13.719616,196521.870820871,1023779.78169705,106.957420349121,133,2.02921091985553,-0.324742864821162 +-150.48574,59.161047,13.719616,200225.713066224,1023779.77443565,121.703704833984,133,2.08530379897341,-0.120997517363346 +-150.42085,59.1592784,13.719616,203929.938052843,1023779.77947687,144.335189819336,133,2.15937222770605,0.148040157027917 +-150.35597,59.1574776,13.719616,207633.982379294,1023779.78883532,169.090423583984,133,2.22811901207792,0.397748100152393 +-150.2911,59.1556444,13.719616,211337.854271582,1023779.77948025,162.961349487305,133,2.21208461241125,0.339506583889724 +-150.22624,59.1537789,13.719616,215041.560136371,1023779.76188831,142.585266113281,133,2.15407465050676,0.128797844561026 +-150.16138,59.1518811,13.719616,218745.676201002,1023779.76832793,125.794052124023,133,2.09966010700127,-0.0688513089078858 +-150.09653,59.149951,13.719616,222449.640250562,1023779.76632394,127.367065429688,133,2.10505714266758,-0.0492477349005097 +-150.03168,59.1479886,13.719616,226154.028508754,1023779.78929467,133.343414306641,133,2.12497157120014,0.0230871536735636 +-149.96685,59.1459939,13.719616,229857.709536731,1023779.76907246,134.406478881836,133,2.12842020379826,0.0356135716076561 +-149.90202,59.1439669,13.719616,233561.828774665,1023779.7737214,137.641891479492,133,2.13875063207925,0.0731366357219892 +-149.8372,59.1419077,13.719616,237265.823299796,1023779.77976185,137.296691894531,133,2.13766007322176,0.0691754146751148 +-149.77239,59.1398162,13.719616,240969.700786487,1023779.77546807,154.655166625977,133,2.18936443322811,0.256980408111808 +-149.70758,59.1376924,13.719616,244674.037448813,1023779.79713289,170.395965576172,133,2.2314593078676,0.409881007875857 +-149.64279,59.1355363,13.719616,248377.70183814,1023779.77109704,190.965148925781,133,2.2809541158851,0.589660277820107 +-149.578,59.133348,13.719616,252081.838640842,1023779.78224263,188.044509887695,133,2.27426065836313,0.565347729597298 +-149.51322,59.1311274,13.719616,255785.886346479,1023779.78207287,173.51985168457,133,2.23934916779475,0.438539231121471 +-149.44845,59.1288746,13.719616,259489.851175027,1023779.78126012,147.155670166016,133,2.16777700088598,0.178568692178535 +-149.38369,59.1265895,13.719616,263193.740853791,1023779.76818555,138.082122802734,133,2.14013745503993,0.0781739725538712 +-149.31894,59.1242723,13.719616,266897.560789335,1023779.76470602,134.380233764648,133,2.12833539224269,0.035305511830209 +-149.25419,59.1219227,13.719616,270601.889510423,1023779.77768029,135.862380981445,133,2.13309922131052,0.0526090987367417 +-149.18946,59.119541,13.719616,274305.59315877,1023779.75921354,147.758636474609,133,2.16955287475565,0.185019172958035 +-149.12473,59.1171271,13.719616,278009.817904187,1023779.77980647,161.410949707031,133,2.20793299281506,0.324426716526148 +-149.06001,59.1146809,13.719616,281714.002296983,1023779.78718277,159.643188476562,133,2.20315039315326,0.307054949464637 +-148.99531,59.1122026,13.719616,285417.582403542,1023779.76029887,161.551452636719,133,2.20831086745595,0.32579926507804 +-148.93061,59.1096921,13.719616,289121.704419348,1023779.7730552,152.172622680664,133,2.18233652570526,0.23145304202427 +-148.86592,59.1071493,13.719616,292825.806920265,1023779.77155557,146.181625366211,133,2.16489278641409,0.168092401979877 +-148.80124,59.1045745,13.719616,296529.894246381,1023779.78892497,156.842163085938,133,2.19546282323419,0.279131501267685 +-148.73657,59.1019674,13.719616,300233.975915759,1023779.79142851,164.80534362793,133,2.21697128909957,0.357256388418083 +-148.67191,59.0993282,13.719616,303938.057094442,1023779.80107624,174.811065673828,133,2.24256892034057,0.450234291376783 +-148.60727,59.0966568,13.719616,307641.576359374,1023779.76013623,195.018524169922,230,2.29007586553014,0.622793076137422 +-148.54263,59.0939533,13.719616,311345.67815376,1023779.77159438,203.174087524414,230,2.30786831796836,0.687420341864572 +-148.478,59.0912176,13.719616,315049.801071178,1023779.77831198,195.591506958008,133,2.29134999277596,0.627421069966377 +-148.41338,59.0884498,13.719616,318753.951087574,1023779.79121671,173.058578491211,133,2.23819313208467,0.43434017945704 +-148.34878,59.0856499,13.719616,322457.565862868,1023779.76155558,145.504180908203,133,2.1628754724922,0.160764942016845 +-148.28418,59.0828178,13.719616,326161.791676044,1023779.77456106,131.078506469727,133,2.11753148431507,-0.00393736550524432 +-148.21959,59.0799537,13.719616,329866.064270583,1023779.8043484,137.571624755859,133,2.13852886643768,0.0723311196135928 +-148.15502,59.0770574,13.719616,333569.823231263,1023779.77826651,140.571395874023,134,2.14789695739866,0.106358699903257 +-148.09046,59.0741291,13.719616,337273.642693305,1023779.76756991,139.310821533203,134,2.14398485331998,0.0921488212638343 +-148.02591,59.0711686,13.719616,340977.531499559,1023779.74987291,147.123870849609,134,2.16768314272887,0.17822777256213 +-147.96136,59.0681761,13.719616,344682.063736444,1023779.79924811,166.975479125977,134,2.22265269832015,0.377892888342877 +-147.89684,59.0651515,13.719616,348385.539597899,1023779.74877546,248.283920288086,134,2.39494859407618,1.00372075987354 +-147.83232,59.0620949,13.719616,352089.672566194,1023779.7652253,297.800445556641,230,2.47392534318998,1.29058685486333 +-147.76781,59.0590062,13.719616,355793.901291679,1023779.78551534,321.922393798828,330,2.50775118844388,1.41345197968293 +-147.70332,59.0558855,13.719616,359497.662348351,1023779.76661108,353.920593261719,430,2.54890583327817,1.5629373964262 +-147.63884,59.0527327,13.719616,363201.532842841,1023779.75038347,550.073120117188,430,2.74042042322644,2.25857305082451 +-139.52388,58.3887524,13.719616,837313.672876045,1023779.75226763,263.388092041016,341,2.42059613631376,1.09687995381781 +-139.46186,58.3815691,13.719616,841017.931162475,1023779.80878256,264.029541015625,241,2.4216525207423,1.1007170435844 +-139.39987,58.3743555,13.719616,844721.949263552,1023779.80584066,224.660614013672,241,2.35152694150762,0.846000923970972 +-139.33791,58.3671118,13.719616,848425.727981187,1023779.76372215,212.404205322266,241,2.32716311095074,0.757504537258815 +-139.27597,58.3598378,13.719616,852129.847079402,1023779.78740923,196.301834106445,143,2.29292435736153,0.633139611509563 +-139.21406,58.3525336,13.719616,855833.740555163,1023779.75910325,138.778305053711,143,2.14232157900154,0.0861073341934704 +-139.15217,58.3451993,13.719616,859537.980799531,1023779.81763142,113.541534423828,40,2.05515475907469,-0.230507435668235 +-139.09031,58.3378348,13.719616,863242.006692096,1023779.82229806,110.780364990234,40,2.04446279169154,-0.269343712995152 +-139.02848,58.3304402,13.719616,866945.821371878,1023779.7825234,96.6554489135742,40,1.98522634223827,-0.484507405175416 +-138.96667,58.3230155,13.719616,870649.999659731,1023779.82794164,75.8815078735352,40,1.8801359523517,-0.86622569702706 +-138.90489,58.3155606,13.719616,874353.980448265,1023779.81622781,90.3094635009766,40,1.95573326228367,-0.591634689733634 +-138.84314,58.3080757,13.719616,878057.764300589,1023779.76771591,127.482856750488,40,2.10545178697201,-0.04781427414412 +-138.78141,58.3005607,13.719616,881761.928528006,1023779.80286096,140.042663574219,143,2.1462603623371,0.100414119508934 +-138.71971,58.2930157,13.719616,885465.906939305,1023779.79946718,136.93586730957,143,2.13651721682959,0.0650242340550618 +-138.65804,58.2854407,13.719616,889169.705075672,1023779.75612217,115.453666687012,40,2.06240773020814,-0.204162574307462 +-138.59639,58.2778357,13.719616,892873.897692679,1023779.80587208,85.2897033691406,40,1.93089660397079,-0.681848521814095 +-138.53477,58.2702006,13.719616,896577.923678112,1023779.80312545,114.32991027832,143,2.0581598626745,-0.219592041651777 +-138.47318,58.2625356,13.719616,900281.7834085,1023779.7682523,61.998363494873,40,1.79238022603815,-1.18497954297587 +-138.41161,58.2548407,13.719616,903986.051591523,1023779.83600058,92.8673782348633,40,1.96786318503114,-0.547575348090189 +-138.35008,58.2471159,13.719616,907689.595268289,1023779.73332842,102.627807617188,143,2.01126505140372,-0.389927381298956 +-138.28857,58.2393611,13.719616,911393.560973688,1023779.72082288,138.377532958984,143,2.14106558358898,0.0815452003582787 +-138.22708,58.2315764,13.719616,915097.951578736,1023779.80968786,144.149887084961,143,2.15881430653416,0.146013628085084 +-138.16563,58.2237619,13.719616,918801.631467871,1023779.73442764,135.581298828125,143,2.13219979000406,0.0493421075084353 +-138.1042,58.2159175,13.719616,922505.747158129,1023779.75901099,141.043884277344,143,2.14935425970666,0.111652037841421 +-138.0428,58.2080434,13.719616,926209.729563292,1023779.76604792,146.79133605957,143,2.16670042334191,0.174658255252652 +-137.98143,58.2001393,13.719616,929913.592075822,1023779.72168509,146.116226196289,143,2.16469844698299,0.167386505696128 +-137.92008,58.1922055,13.719616,933617.90134903,1023779.79777498,144.011001586914,143,2.15839567088679,0.144493023923308 +-137.85877,58.184242,13.719616,937321.524316221,1023779.71243043,150.147155761719,143,2.1765171097705,0.210315262322545 +-137.79748,58.1762487,13.719616,941025.607484532,1023779.73526061,152.538070678711,143,2.18337824907454,0.235236878638943 +-137.73622,58.1682256,13.719616,944729.587025461,1023779.72443294,153.540328979492,143,2.18622246680245,0.245567889247293 +-137.67498,58.1601728,13.719616,948434.034826036,1023779.83235744,151.75895690918,143,2.18115433283748,0.227158980097083 +-137.61378,58.1520904,13.719616,952137.81506665,1023779.78356507,156.160003662109,143,2.19356981050726,0.272255538723843 +-137.55261,58.1439783,13.719616,955841.505020049,1023779.70824703,148.845260620117,143,2.17273501083831,0.196577599482325 +-137.49146,58.1358365,13.719616,959545.679244036,1023779.74967611,138.511383056641,143,2.14148546578707,0.0830703323480706 +-137.43034,58.1276651,13.719616,963249.771091149,1023779.77410666,131.81950378418,143,2.11997967246727,0.00495515264600562 +-137.36925,58.119464,13.719616,966953.788625562,1023779.76951657,130.856079101562,143,2.11679390320011,-0.00661647064140879 +-137.30819,58.1112334,13.719616,970657.731609384,1023779.75636899,129.655899047852,143,2.11279228096383,-0.0211515047802787 +-137.24716,58.1029732,13.719616,974361.608084648,1023779.72266157,126.363304138184,143,2.10162097328107,-0.0617288828927224 +-137.18615,58.0946835,13.719616,978065.989750395,1023779.82531995,129.795257568359,143,2.11325882459441,-0.0194568851491976 +-137.12518,58.0863642,13.719616,981769.746215821,1023779.75837789,171.145797729492,240,2.23336624004826,0.416807529848616 +-137.06423,58.0780155,13.719616,985474.01554986,1023779.83742083,292.276763916016,340,2.46579429019775,1.26105254956196 +-137.00332,58.0696372,13.719616,989177.670167683,1023779.7434629,355.474182128906,340,2.55080806367023,1.56984684016075 +-136.94243,58.0612295,13.719616,992881.848086317,1023779.79433186,377.704864501953,350,2.57715257818932,1.66553763636718 +-136.88157,58.0527923,13.719616,996585.988120519,1023779.8297093,365.813690185547,350,2.56325995445036,1.61507566159767 +-136.82075,58.0443257,13.719616,1000289.52340287,1023779.70866735,359.391845703125,350,2.55556821911043,1.5871370834032 +-136.75995,58.0358296,13.719616,1003993.60041621,1023779.71998891,328.97802734375,350,2.51716689210793,1.44765250290014 +-136.69918,58.0273042,13.719616,1007697.64938351,1023779.73411466,192.037704467773,250,2.28338650596752,0.598495412872703 +-136.63844,58.0187495,13.719616,1011401.67543755,1023779.74995399,89.167106628418,50,1.95020467450663,-0.611716098555927 +-136.57773,58.0101653,12.0380433,1015105.68949936,1023779.74484874,19.8169136047363,50,1.29703601600155,-2.98421109914244 +-153.99632,59.1753127,8.133448402,209.678292161978,1020075.77901504,14.795581817627,32,1.17013204791616,-3.44516253322727 +-153.93131,59.1752946,13.61171474,3913.80625818026,1020075.77369799,13.7116069793701,32,1.13708835642152,-3.56518665234434 +-153.8663,59.1752441,13.719616,7617.94172799158,1020075.7720833,17.8965682983398,32,1.25276976215442,-3.14499876796197 +-153.8013,59.1751612,13.719616,11321.5220117148,1020075.77249344,11.9949340820312,32,1.07899786565202,-3.776187895496 +-153.73629,59.1750459,13.719616,15025.6937533128,1020075.77782514,21.6443977355957,32,1.33534550589201,-2.84506009724325 +-153.67128,59.1748981,13.719616,18729.8943180814,1020075.77581391,32.9000015258789,32,1.51719591809225,-2.18452749485674 +-153.60628,59.1747179,13.719616,22433.5609824054,1020075.77434154,36.6136741638184,32,1.56364331230155,-2.01581730168235 +-153.54127,59.1745053,13.719616,26137.8403898628,1020075.77970371,41.8843536376953,32,1.622051817767,-1.8036609383846 +-153.47627,59.1742602,13.719616,29841.6001601349,1020075.77352212,40.2000007629395,32,1.60422606132677,-1.86840917375296 +-153.41126,59.1739827,13.719616,33545.9868701079,1020075.77553824,39.1214408874512,32,1.59241484197305,-1.91131089370329 +-153.34626,59.1736728,13.719616,37249.8680508209,1020075.77635736,37.9554328918457,32,1.57927394903453,-1.95904236764026 +-153.28126,59.1733305,13.719616,40953.8205669347,1020075.78064058,40.2137985229492,32,1.60437509771472,-1.86786783105269 +-153.21626,59.1729557,13.719616,44657.8516367602,1020075.77739387,58.4847946166992,32,1.76704296911772,-1.277011692084 +-153.15126,59.1725485,13.719616,48361.968236274,1020075.77799921,75.1751022338867,32,1.87607402738889,-0.880979767880796 +-153.08627,59.1721089,13.719616,52065.6076731569,1020075.77483684,83.4480972290039,32,1.92141643841053,-0.716283189037594 +-153.02127,59.1716369,13.719616,55769.9165885876,1020075.78326653,98.2232360839844,32,1.99221423839124,-0.459125371803683 +-152.95628,59.1711324,13.719616,59473.7626871183,1020075.77612739,123.48469543457,32,2.09161313492209,-0.0980802083339826 +-152.89129,59.1705955,13.719616,63177.7226772281,1020075.77271087,136.549850463867,132,2.13529122887888,0.0605710958862819 +-152.8263,59.1700262,13.719616,66881.8036427339,1020075.77330721,136.133758544922,132,2.1339658352091,0.0557568877726407 +-152.76131,59.1694245,13.719616,70586.0126669216,1020075.77822416,137.781494140625,132,2.13919089005113,0.0747357783380032 +-152.69633,59.1687904,13.719616,74289.7870545398,1020075.77660056,133.28923034668,132,2.12479506021685,0.0224460154010003 +-152.63135,59.1681239,13.719616,77993.7036656725,1020075.77885005,132.893661499023,32,2.12350426731109,0.0177574871383006 +-152.56637,59.1674249,13.719616,81697.769823133,1020075.77415558,111.360275268555,32,2.046730295789,-0.261107490903097 +-152.50139,59.1666936,13.719616,85401.9921360394,1020075.78524963,108.389274597168,32,2.03498630975109,-0.303765000260105 +-152.43642,59.1659298,13.719616,89105.8084001375,1020075.77675585,103.27197265625,32,2.01398247280422,-0.380056931143072 +-152.37145,59.1651336,13.719616,92809.7952314825,1020075.77256604,105.728782653809,132,2.02419323183065,-0.342968539918276 +-152.30648,59.1643051,13.719616,96513.9594236708,1020075.78428662,112.087326049805,132,2.04955650877866,-0.250841878643155 +-152.24152,59.1634441,13.719616,100217.738835788,1020075.77492201,125.188507080078,132,2.09756446033759,-0.0764632957474829 +-152.17656,59.1625507,13.719616,103921.710048728,1020075.77008892,136.81022644043,132,2.13611856171636,0.0635762048962948 +-152.1116,59.161625,13.719616,107625.879820833,1020075.78144526,136.37712097168,132,2.13474151790719,0.0585743887339639 +-152.04665,59.1606668,13.719616,111329.686074243,1020075.77037642,110.929679870605,32,2.04504775967038,-0.267218942329529 +-151.9817,59.1596763,13.719616,115033.705014694,1020075.77539847,121.496429443359,33,2.08456351500567,-0.12368644003226 +-151.91675,59.1586534,13.70935988,118737.944033508,1020075.78587107,45.8060722351074,33,1.6609230536239,-1.66246951479703 +-151.78687,59.1565104,8.341085088,126145.971039284,1020075.78740553,28.9496402740479,33,1.46164317158792,-2.38631092649292 +-151.65701,59.1542378,10.48737363,133553.82365928,1020075.77291542,28.5748176574707,33,1.45598346774249,-2.40686858629984 +-151.59209,59.153053,11.87539066,137257.559397623,1020075.76509777,27.6318378448486,33,1.44140977160967,-2.45980441040126 +-151.52717,59.1518358,11.60392471,140961.557611758,1020075.76295933,21.5468826293945,33,1.33338444596848,-2.85218322662774 +-151.46225,59.1505863,12.02603189,144665.824940583,1020075.77832867,37.1905288696289,33,1.57043235430757,-1.99115756333098 +-151.39734,59.1493044,13.71410628,148369.799076201,1020075.77836653,117.045196533203,33,2.06835359520539,-0.182565495518632 +-151.33243,59.1479901,13.719616,152074.056860168,1020075.78499029,173.734405517578,33,2.23988583253346,0.44048855063183 +-151.26753,59.1466435,13.719616,155778.035116988,1020075.78662271,121.136581420898,33,2.08327531333431,-0.128365556192021 +-151.20264,59.1452645,13.719616,159481.741345733,1020075.77114589,60.0520973205566,33,1.77852817974623,-1.23529412887579 +-151.13775,59.1438532,13.719616,163185.751902418,1020075.77337188,101.847450256348,33,2.0079501609409,-0.401968009623868 +-151.07286,59.1424095,13.719616,166890.07430529,1020075.78289161,124.480049133301,33,2.09509975106526,-0.0854158233226767 +-151.00799,59.1409336,13.719616,170593.5750484,1020075.77144523,94.1777801513672,33,1.97394844954508,-0.525471930468143 +-150.94311,59.1394252,13.719616,174297.971999052,1020075.78171148,75.7343673706055,33,1.87929300198854,-0.869287533348032 +-150.87825,59.1378846,13.719616,178001.561334246,1020075.76927131,93.4947204589844,33,1.9707870874472,-0.536954899950208 +-150.81338,59.1363116,13.719616,181706.060447606,1020075.79135435,143.866851806641,133,2.15796074017826,0.142913231448363 +-150.74853,59.1347063,13.719616,185409.766509282,1020075.7778924,129.046142578125,133,2.1107450272288,-0.0285877146902774 +-150.68368,59.1330686,13.719616,189113.826650197,1020075.77218936,120.180358886719,33,2.07983349658427,-0.140867217020481 +-150.61884,59.1313987,13.719616,192817.677002599,1020075.76842405,89.5171051025391,33,1.9519060290797,-0.605536293131566 +-150.554,59.1296965,13.719616,196521.894905397,1020075.78424673,100.752532958984,133,2.00325597328741,-0.419018639035904 +-150.48917,59.1279619,13.719616,200225.918183548,1020075.7792592,111.121383666992,133,2.04579764053372,-0.264495160996575 +-150.42435,59.1261951,13.719616,203929.752677011,1020075.77504936,134.713989257812,133,2.12941269699999,0.0392185902021116 +-150.35953,59.124396,13.719616,207633.975752452,1020075.79099409,164.021286010742,133,2.21490021266435,0.349733647661316 +-150.29472,59.1225645,13.719616,211338.025262474,1020075.78507542,166.769302368164,133,2.22211611201486,0.375943853725094 +-150.22992,59.1207008,13.719616,215041.906976534,1020075.77892932,163.275756835938,133,2.21292170553284,0.342547145037501 +-150.16513,59.1188049,13.719616,218745.627865595,1020075.77188205,173.064163208008,133,2.23820714683375,0.434391085025909 +-150.10034,59.1168766,13.719616,222449.765988973,1020075.77445227,150.415161132812,133,2.17729161328003,0.213128480134483 +-150.03556,59.1149161,13.719616,226153.757267413,1020075.77594326,148.903945922852,133,2.17290620661594,0.197199431410816 +-149.97079,59.1129233,13.719616,229857.609344262,1020075.7645737,151.957183837891,133,2.18172123635019,0.229218135465612 +-149.90602,59.1108983,13.719616,233561.898304995,1020075.78606777,157.751007080078,133,2.19797214045452,0.288246057642366 +-149.84126,59.108841,13.719616,237266.062032949,1020075.79462608,169.152389526367,133,2.22827813721584,0.398326088072166 +-149.77652,59.1067515,13.719616,240969.537032034,1020075.76455194,180.20751953125,133,2.2557729088561,0.498194946458729 +-149.71177,59.1046297,13.719616,244674.040315283,1020075.79298897,204.844711303711,230,2.31142475578604,0.700338339126806 +-149.64704,59.1024757,13.719616,248377.868804927,1020075.78170408,205.159194946289,230,2.3120909862064,0.702758278174645 +-149.58232,59.1002895,13.719616,252081.599232647,1020075.76646202,208.984375,133,2.32011381670938,0.731899488505282 +-149.5176,59.098071,13.719616,255785.80908205,1020075.77412147,200.777694702148,133,2.30271546342396,0.668703703388197 +-149.45289,59.0958204,13.719616,259489.934027619,1020075.78910532,180.996139526367,133,2.25766931188423,0.505083223544207 +-149.38819,59.0935375,13.719616,263193.982535611,1020075.78863753,162.482437133789,133,2.21080642458815,0.334863840885097 +-149.3235,59.0912224,13.719616,266897.960797315,1020075.7834203,146.691848754883,133,2.16640598201555,0.1735887603134 +-149.25882,59.0888752,13.719616,270601.874958372,1020075.78416977,139.686004638672,133,2.14515289564407,0.096391484377387 +-149.19415,59.0864957,13.719616,274305.733543659,1020075.76816545,140.174438476562,133,2.14666882503792,0.101897772625176 +-149.12949,59.0840841,13.719616,278009.54188607,1020075.75730754,148.469039916992,133,2.17163590015134,0.19258531574985 +-149.06483,59.0816403,13.719616,281713.877497357,1020075.78248083,145.167602539062,133,2.16186970446035,0.157111705450383 +-149.00019,59.0791643,13.719616,285417.607755622,1020075.75903665,147.105422973633,133,2.16762868308859,0.178029959604323 +-148.93555,59.0766562,13.719616,289121.878296805,1020075.7831689,152.294784545898,133,2.18268503083624,0.232718912133257 +-148.87093,59.0741159,13.719616,292825.557324314,1020075.75688324,162.810104370117,133,2.21168135470557,0.338041836801499 +-148.80631,59.0715435,13.719616,296529.790447642,1020075.77863658,172.057723999023,133,2.23567417370126,0.425190603626168 +-148.7417,59.0689389,13.719616,300234.015665043,1020075.79344746,177.362869262695,133,2.24886270590073,0.473095116956509 +-148.67711,59.0663022,13.719616,303937.669225555,1020075.7664105,184.776260375977,133,2.26664617332354,0.537689746543119 +-148.61252,59.0636334,13.719616,307641.897572185,1020075.7882319,206.094192504883,230,2.31406575403725,0.709931198591156 +-148.54795,59.0609324,13.719616,311345.568950303,1020075.7554284,226.190185546875,230,2.35447375684361,0.856704598376117 +-148.48338,59.0581994,13.719616,315049.827975244,1020075.78325476,213.738952636719,230,2.3298836769305,0.767386409424123 +-148.41883,59.0554342,13.719616,318753.543814848,1020075.75488967,201.974182128906,230,2.30529585818149,0.678076433665545 +-148.35428,59.0526369,13.719616,322457.861985196,1020075.77670987,188.20817565918,133,2.27463848501338,0.566720103833494 +-148.28975,59.0498076,13.719616,326161.648844565,1020075.76311672,169.333053588867,133,2.22874174009431,0.400010026052173 +-148.22522,59.0469462,13.719616,329866.051758901,1020075.80047,140.228286743164,133,2.1468356280197,0.102503648665304 +-148.16071,59.0440527,13.719616,333569.938041207,1020075.7898356,138.288513183594,134,2.14078610730986,0.0805300627420653 +-148.09621,59.0411271,13.719616,337273.884335671,1020075.78019161,140.147674560547,134,2.14658589600354,0.101596550701999 +-148.03172,59.0381695,13.719616,340977.896502481,1020075.78255419,137.869247436523,134,2.13946740498627,0.0757401595076704 +-147.96724,59.0351799,13.719616,344681.981369927,1020075.79681919,138.712814331055,134,2.14211658318,0.0853627308580205 +-147.90278,59.0321582,13.719616,348385.577010466,1020075.75930802,296.667266845703,230,2.47226963053485,1.28457283391242 +-147.83832,59.0291044,13.719616,352089.829835141,1020075.77431299,377.00634765625,330,2.57634866248397,1.66261758506496 +-147.77388,59.0260187,13.719616,355793.605047236,1020075.75856691,398.583160400391,430,2.6005189463974,1.75041095512438 +-147.70944,59.0229009,13.719616,359498.05110189,1020075.7963622,580.091430664062,430,2.7634964499482,2.34239176643172 +-139.47564,58.3492121,12.01492026,841018.004488778,1020075.82008176,639.929809570312,440,2.80613234119012,2.49725749291731 +-139.41371,58.3420051,13.719616,844721.733321587,1020075.75729325,259.873779296875,241,2.41476246233615,1.0756903848348 +-139.3518,58.334768,13.719616,848425.788857925,1020075.77896214,245.763244628906,241,2.39051693205555,0.98762369849233 +-139.28992,58.3275006,13.719616,852129.611857636,1020075.73511346,219.46745300293,241,2.34137012353356,0.809108462044694 +-139.22806,58.3202031,13.719616,855833.772851893,1020075.77490566,175.310440063477,143,2.24380777990982,0.454734182938027 +-139.16623,58.3128754,13.719616,859537.710154508,1020075.75817883,148.312561035156,143,2.17117793428692,0.19092185301378 +-139.10442,58.3055176,13.719616,863241.996699482,1020075.82432117,130.394317626953,40,2.11525866595856,-0.0121928905030424 +-139.04264,58.2981297,13.719616,866946.068313997,1020075.84297823,106.442085266113,143,2.0271133740595,-0.332361749851523 +-138.98089,58.2907117,13.719616,870649.930597446,1020075.81267698,100.254669189453,40,2.00110460828467,-0.426833010786561 +-138.91917,58.2832636,13.719616,874353.589143423,1020075.73195665,65.8709487915039,40,1.81869391897434,-1.08940069955594 +-138.85747,58.2757854,13.719616,878057.619317696,1020075.73158421,145.941131591797,40,2.16417770934277,0.165495037953509 +-138.79579,58.2682773,13.719616,881762.021630634,1020075.83356047,155.809127807617,143,2.19259289647108,0.268707108105428 +-138.73415,58.2607391,13.719616,885465.667133684,1020075.74969842,153.97492980957,143,2.1874500147865,0.250026693902425 +-138.67253,58.2531709,13.719616,889169.698397108,1020075.75556737,149.905136108398,143,2.17581651307058,0.207770495138244 +-138.61094,58.2455727,13.719616,892873.551177127,1020075.71698647,140.685989379883,143,2.14825084911934,0.107644135643514 +-138.54937,58.2379446,13.719616,896577.798203939,1020075.77843673,133.863189697266,143,2.1266611691765,0.0292242557829584 +-138.48783,58.2302865,13.719616,900281.877777998,1020075.79376855,127.705146789551,143,2.10620840060922,-0.0450660374547668 +-138.42632,58.2225985,13.719616,903985.792819641,1020075.77247764,143.624298095703,143,2.15722791926704,0.140251416730901 +-138.36484,58.2148806,13.719616,907689.548809368,1020075.71319676,135.679428100586,143,2.13251400433125,0.050483423630475 +-138.30338,58.2071329,13.719616,911393.718383437,1020075.76266821,129.947418212891,143,2.11376765538737,-0.0176086664743874 +-138.24195,58.1993552,13.719616,915097.742455101,1020075.76170128,117.497512817383,143,2.07002867357696,-0.176481132758129 +-138.18055,58.1915477,13.719616,918801.621244474,1020075.73068646,155.085601806641,143,2.19057147965639,0.261364745264653 +-138.11917,58.1837104,13.719616,922505.929956237,1020075.80720457,149.64338684082,143,2.17505752891426,0.205013648046841 +-138.05783,58.1758433,13.719616,926209.534455214,1020075.71268043,145.846786499023,143,2.16389686457797,0.164474929606674 +-137.99651,58.1679464,13.719616,929913.579712152,1020075.72418432,149.19401550293,143,2.17375140298799,0.200269425877167 +-137.93521,58.1600197,13.719616,933618.071135872,1020075.84209668,151.374252319336,143,2.18005201105193,0.223155032737979 +-137.87395,58.1520633,13.719616,937321.871886911,1020075.79537544,154.651977539062,143,2.18935547771011,0.256947879114258 +-137.81272,58.1440772,13.719616,941025.557110098,1020075.72276721,157.109390258789,143,2.19620214312845,0.281816922146555 +-137.75151,58.1360613,13.719616,944729.704650599,1020075.75442125,158.084564208984,143,2.19888946635135,0.291578047130529 +-137.69033,58.1280157,13.719616,948433.747398917,1020075.75878848,157.744171142578,143,2.19795332045257,0.288177698023505 +-137.62918,58.1199405,13.719616,952137.687977607,1020075.7454604,158.864669799805,143,2.20102732441304,0.299343357816022 +-137.56806,58.1118357,13.719616,955841.531699572,1020075.71319752,150.16325378418,143,2.17656367014342,0.210484382886666 +-137.50696,58.1037012,13.719616,959545.856395805,1020075.79442805,145.132537841797,143,2.16176478956374,0.156730624600222 +-137.4459,58.0955371,13.719616,963249.525084917,1020075.7103557,129.812042236328,143,2.11331498240426,-0.0192529039547734 +-137.38486,58.0873434,13.719616,966953.682617591,1020075.74930416,134.65461730957,143,2.12922124996949,0.0385231999429023 +-137.32385,58.0791201,13.719616,970657.764504525,1020075.76559304,132.821365356445,143,2.12326794031874,0.0168990800476486 +-137.26287,58.0708673,13.719616,974361.773242412,1020075.7688579,138.122268676758,143,2.14026370308102,0.0786325414738876 +-137.20192,58.062585,13.719616,978065.714077974,1020075.75791856,147.776306152344,143,2.16960480664213,0.18520780439258 +-137.141,58.0542731,13.719616,981769.595057499,1020075.72079223,215.893890380859,240,2.33424035233227,0.783211098002324 +-137.0801,58.0459318,13.719616,985473.985592023,1020075.82634082,327.393859863281,340,2.51507053013853,1.44003791786603 +-137.01924,58.037561,13.719616,989177.754149763,1020075.76637854,396.692291259766,340,2.59845376110971,1.74290961269693 +-136.9584,58.0291607,13.719616,992882.045508884,1020075.83710703,422.485137939453,350,2.62581143606817,1.84228049680391 +-136.8976,58.0207311,13.719616,996585.719639108,1020075.7605538,408.327362060547,350,2.61100848301816,1.78851194614281 +-136.83682,58.012272,13.719616,1000289.92695722,1020075.81355643,376.855926513672,350,2.5761753494657,1.66198806271413 +-136.77608,58.0037835,13.719616,1003993.53024608,1020075.7051248,337.275207519531,350,2.52798441817352,1.4869448451997 +-136.71536,57.9952657,13.719616,1007697.67135479,1020075.74675271,201.929107666016,150,2.30519892611342,0.67772434872716 +-136.65467,57.9867185,13.719616,1011401.78852228,1020075.77592874,86.4540176391602,50,1.93678518035111,-0.660459531633715 +-136.59401,57.978142,13.68796099,1015105.88400965,1020075.80236304,27.9531803131104,50,1.44643122595627,-2.44156505494865 +-153.73655,59.141915,13.719616,15025.573000545,1016371.77513985,25.082633972168,32,1.39937314059223,-2.61249345270565 +-153.6716,59.1417674,13.719616,18729.9772343442,1016371.78049831,17.283712387085,32,1.2376370307391,-3.19996516777398 +-153.60666,59.1415873,13.719616,22433.847013992,1016371.77212912,23.7983283996582,32,1.37654645317837,-2.69540649677804 +-153.54172,59.1413749,13.719616,26137.759637695,1016371.77475118,39.7316398620605,32,1.59913649025915,-1.88689594857875 +-153.47678,59.1411301,13.719616,29841.7222445468,1016371.77729962,41.8831481933594,32,1.6220393184609,-1.80370633943202 +-153.41184,59.1408529,13.719616,33545.741918134,1016371.77990666,45.7000007629395,32,1.65991620732019,-1.66612666795467 +-153.3469,59.1405432,13.719616,37249.8258517408,1016371.77154284,43.2126274108887,32,1.63561067305412,-1.75441130589918 +-153.28196,59.1402012,13.719616,40953.9809194646,1016371.77473384,42.0999984741211,32,1.62428208009503,-1.79555998902895 +-153.21703,59.1398268,13.719616,44657.643967346,1016371.77176061,61.5265731811523,32,1.78906272705032,-1.19702964620818 +-153.15209,59.13942,13.719616,48361.9627491901,1016371.77571651,84.6565933227539,32,1.92766078798754,-0.693601929059098 +-153.08716,59.1389808,13.719616,52065.8036755932,1016371.77281459,103.640975952148,32,2.01553149393784,-0.374430444251105 +-153.02223,59.1385092,13.719616,55769.7441638686,1016371.77001646,119.608451843262,132,2.07776186911059,-0.148391959306214 +-152.9573,59.1380053,13.719616,59473.7911196555,1016371.77875506,135.525756835938,132,2.13202184125242,0.0486957468508395 +-152.89237,59.1374689,13.719616,63177.9519637587,1016371.77694574,142.300354003906,132,2.15320598049013,0.125642587117531 +-152.82745,59.1369002,13.719616,66881.6630786885,1016371.77716363,143.485900878906,132,2.15680922879603,0.138730613434017 +-152.76252,59.136299,13.719616,70586.0725993368,1016371.77694376,147.665145874023,132,2.16927799875902,0.184020744880877 +-152.6976,59.1356655,13.719616,74290.046527695,1016371.77826685,141.139343261719,132,2.14964809227854,0.112719321610629 +-152.63269,59.1349996,13.719616,77993.5921396305,1016371.76862372,138.253280639648,132,2.14067544555932,0.0801281076780781 +-152.56777,59.1343014,13.719616,81697.856943335,1016371.78248137,118.956535339355,132,2.0753883066831,-0.157013415525031 +-152.50286,59.1335707,13.719616,85401.707815838,1016371.7738164,120.969863891602,132,2.08267719200498,-0.130538103580965 +-152.43795,59.1328077,13.719616,89105.7216762659,1016371.77712118,122.165634155273,132,2.08694905373174,-0.115021482478658 +-152.37304,59.1320123,13.719616,92809.9058414915,1016371.78163043,114.44921875,132,2.05861283245205,-0.217946726129268 +-152.30814,59.1311845,13.719616,96513.6970508439,1016371.77324063,123.28443145752,132,2.09090823670126,-0.100640599870015 +-152.24324,59.1303244,13.719616,100217.672418584,1016371.77699152,137.245162963867,132,2.13749704721962,0.0685832577030962 +-152.17834,59.1294319,13.719616,103921.839291997,1016371.78217095,151.653793334961,132,2.18085327784377,0.22606546243025 +-152.11345,59.128507,13.719616,107625.634407971,1016371.77305443,162.317901611328,132,2.21036641965545,0.333265617379643 +-152.04856,59.1275498,13.719616,111329.634845461,1016371.77640632,126.027267456055,32,2.10046451991534,-0.0659294516017095 +-151.98367,59.1265602,13.719616,115033.847981891,1016371.78156758,133.013549804688,33,2.12389588386686,0.0191799502473525 +-151.91879,59.1255382,13.719616,118737.710551413,1016371.77119277,109.404106140137,33,2.03903362218515,-0.28906400628164 +-151.85391,59.1244839,13.60389263,122441.799597416,1016371.77377068,59.1495208740234,33,1.77195123108381,-1.25918348366575 +-151.78904,59.1233973,13.09958055,126145.551819333,1016371.77087418,45.3449745178223,33,1.65652916217633,-1.67842938267609 +-151.6593,59.1211269,7.849045811,133553.786115258,1016371.77113452,17.0932140350342,33,1.23282373073959,-3.21744844722481 +-151.59444,59.1199433,13.719616,137257.711174322,1016371.77719219,59.8164253234863,33,1.77682045569176,-1.24149707007459 +-151.52958,59.1187272,12.27251956,140961.898728328,1016371.77463995,29.5510845184326,33,1.47057342402363,-2.35387370069861 +-151.39988,59.1161982,13.62841092,148369.945965992,1016371.77986505,49.538402557373,33,1.69494199797643,-1.53890299893522 +-151.33504,59.1148852,13.719616,152073.820132103,1016371.77560057,64.3010635375977,132,1.8082181562009,-1.12745166002946 +-151.2702,59.1135399,13.719616,155777.98411674,1016371.78556171,96.890754699707,132,1.98628233871786,-0.480671724550153 +-151.20537,59.1121622,13.719616,159481.875079254,1016371.775288,123.36971282959,132,2.09120855381843,-0.0995497623814161 +-151.14054,59.1107523,13.719616,163186.069449096,1016371.79075893,141.040832519531,132,2.14934486280212,0.111617905601984 +-151.07572,59.10931,13.719616,166890.00486418,1016371.78526397,140.736434936523,33,2.14840654550475,0.10820966935551 +-151.01091,59.1078354,13.719616,170593.687874937,1016371.769075,140.067367553711,132,2.14633696653409,0.100692367817433 +-150.9461,59.1063285,13.719616,174297.695836412,1016371.7675568,159.293258666992,133,2.20219739673223,0.303593394451209 +-150.88129,59.1047894,13.719616,178002.035241707,1016371.7926865,173.130081176758,133,2.23837253265918,0.434991813549665 +-150.8165,59.1032179,13.719616,181705.573474571,1016371.76823486,130.380462646484,133,2.11521251777227,-0.0123605138876567 +-150.7517,59.1016141,13.719616,185410.028043162,1016371.78662316,123.259918212891,33,2.09082187522573,-0.100954289399172 +-150.68692,59.0999781,13.719616,189113.69439631,1016371.77612308,125.309440612793,33,2.09798379127822,-0.0749401660821629 +-150.62214,59.0983097,13.719616,192817.72132138,1016371.77000344,105.68546295166,33,2.02401525415644,-0.343615005630899 +-150.55737,59.0966091,13.719616,196521.5443671,1016371.76189917,102.52025604248,133,2.01080968215615,-0.391581412381455 +-150.4926,59.0948762,13.719616,200225.741435342,1016371.77003428,111.254234313965,133,2.04631654912887,-0.262610336867717 +-150.42784,59.0931111,13.719616,203929.748596395,1016371.77579536,129.563430786133,133,2.1124824394289,-0.0222769376727049 +-150.36309,59.0913137,13.719616,207633.573434886,1016371.76729245,173.0400390625,133,2.23814660446979,0.434171177879481 +-150.29834,59.089484,13.719616,211337.793290173,1016371.77563986,187.736801147461,133,2.27354941363721,0.562764285743319 +-150.2336,59.0876221,13.719616,215041.844194783,1016371.78060068,173.288330078125,133,2.2387693165897,0.436433046038733 +-150.16887,59.0857279,13.719616,218745.73376079,1016371.77033818,178.929000854492,133,2.2526807368241,0.486963295044714 +-150.10414,59.0838015,13.719616,222450.038666813,1016371.78885156,188.977828979492,133,2.2764108554078,0.573157858990898 +-150.03943,59.0818429,13.719616,226153.625205339,1016371.76906505,189.931396484375,133,2.27859676143457,0.581097693599803 +-149.97472,59.079852,13.719616,229857.641687013,1016371.76674474,190.051696777344,133,2.27887175132796,0.582096535382529 +-149.91002,59.0778289,13.719616,233561.524080851,1016371.75894739,198.81330871582,133,2.29844545304108,0.653193806895298 +-149.84532,59.0757736,13.719616,237265.849680817,1016371.78080933,203.81721496582,230,2.309240862933,0.692405816939482 +-149.78063,59.0736861,13.719616,240970.055107508,1016371.79714582,218.623260498047,230,2.33969636698482,0.803028900522018 +-149.71596,59.0715663,13.719616,244673.577700219,1016371.75940206,220.278305053711,230,2.34297172611389,0.814925939759364 +-149.65129,59.0694144,13.719616,248377.563652253,1016371.76247844,218.122970581055,230,2.33870140364056,0.799414909664856 +-149.58662,59.0672303,13.719616,252082.020623703,1016371.79636907,216.359237670898,230,2.33517544256155,0.786607612616398 +-149.52197,59.0650139,13.719616,255785.815644641,1016371.77405685,217.442535400391,230,2.3373445033324,0.794486260447702 +-149.45733,59.0627654,13.719616,259489.524501308,1016371.75476199,203.128433227539,230,2.30777071872504,0.687065833555249 +-149.39269,59.0604847,13.719616,263193.72521582,1016371.76648952,201.103073120117,133,2.30341870723976,0.671258085652973 +-149.32806,59.0581719,13.719616,266897.853608548,1016371.78142106,191.824157714844,133,2.28290329992321,0.596740270599037 +-149.26344,59.0558269,13.719616,270601.917383283,1016371.78796603,177.212753295898,133,2.24849497311949,0.471759406533681 +-149.19883,59.0534497,13.719616,274305.923477517,1016371.78570388,162.736709594727,133,2.21148553066353,0.337330547987046 +-149.13423,59.0510404,13.719616,278009.878008151,1016371.78538023,158.852432250977,133,2.20099386886471,0.29922183771534 +-149.06964,59.0485989,13.719616,281713.788704811,1016371.77545755,163.384094238281,133,2.21320977483546,0.343593494967788 +-149.00506,59.0461253,13.719616,285417.661658148,1016371.76671361,168.22624206543,133,2.22589374351455,0.389665289575327 +-148.94048,59.0436196,13.719616,289122.074099695,1016371.8023282,179.139953613281,133,2.25319245742171,0.488822010314852 +-148.87592,59.0410817,13.719616,292825.893113216,1016371.78430418,186.051147460938,133,2.26963235285482,0.548536402941222 +-148.81137,59.0385117,13.719616,296529.695085482,1016371.76644485,190.80012512207,133,2.2805786551679,0.588296497328075 +-148.74682,59.0359096,13.719616,300234.057240883,1016371.79365365,194.796340942383,230,2.28958079482465,0.620994838027833 +-148.68229,59.0332754,13.719616,303937.845794252,1016371.77578332,218.698623657227,230,2.33984604988742,0.803572591548001 +-148.61777,59.0306092,13.719616,307641.637060061,1016371.76835555,244.648696899414,230,2.3885429068693,0.98045347557299 +-148.55325,59.0279108,13.719616,311346.010054484,1016371.79571167,238.148315429688,230,2.37684751382502,0.937972469838652 +-148.48875,59.0251803,13.719616,315049.830090675,1016371.77555152,227.864807128906,230,2.3576772551938,0.86834061875346 +-148.42426,59.0224178,13.719616,318753.673443066,1016371.76511749,229.901901245117,230,2.36154256281712,0.882380519310013 +-148.35978,59.0196232,13.719616,322457.547901094,1016371.75306365,221.483291625977,230,2.34534096925734,0.823531707105684 +-148.2953,59.0167966,13.719616,326162.029712368,1016371.79945254,213.904067993164,230,2.33021904399268,0.768604558317249 +-148.23084,59.0139379,13.719616,329865.986011298,1016371.79530601,169.052200317383,134,2.22802082774585,0.397391466633716 +-148.16639,59.0110471,13.719616,333569.993999265,1016371.78902449,150.666290283203,134,2.17801609517049,0.215760005148348 +-148.10195,59.0081244,13.719616,337274.058556224,1016371.80273995,149.746368408203,134,2.17535629884497,0.206098865712619 +-148.03753,59.0051696,13.719616,340977.618146524,1016371.76271404,167.386657714844,134,2.22372083769696,0.381772675436804 +-147.97311,59.0021828,13.719616,344681.819285957,1016371.78210445,285.506164550781,230,2.45561548981999,1.22408024127105 +-147.90871,58.9991639,13.719616,348385.529149317,1016371.74644357,476.473266601562,330,2.67803853877682,2.03198424094096 +-147.84431,58.9961131,13.719616,352089.893190519,1016371.78228199,560.541259765625,430,2.74860758522545,2.28831116005358 +-147.77993,58.9930303,13.719616,355793.778567916,1016371.77295326,636.328247070312,430,2.80368120230974,2.48835425687908 +-139.24203,58.2878702,11.9530277,855834.032785803,1016371.83113813,431.407562255859,341,2.63488775369468,1.87524827306237 +-139.18026,58.2805492,13.00546359,859537.658566113,1016371.75063175,377.568328857422,341,2.57699555771469,1.66496729318521 +-139.11851,58.273198,13.719616,863241.632914662,1016371.73794485,156.217681884766,143,2.19373018901872,0.272838079254041 +-139.05678,58.2658168,13.719616,866945.95647966,1016371.81504927,160.344741821289,143,2.20505472269638,0.31397201791503 +-138.99508,58.2584055,13.719616,870650.066996333,1016371.84014141,146.855758666992,143,2.16689098121811,0.17535041584965 +-138.93341,58.2509641,13.719616,874353.970057057,1016371.81175339,157.449157714844,143,2.19714034169042,0.28522472711213 +-138.87177,58.2434928,13.719616,878057.666201786,1016371.75019901,159.834060668945,143,2.20366933307768,0.308939887390353 +-138.81015,58.2359914,13.719616,881761.73635325,1016371.76502898,166.717178344727,143,2.22198035133341,0.375450732180114 +-138.74856,58.22846,13.719616,885465.613207231,1016371.73403387,162.895492553711,143,2.21190906720517,0.338868953595653 +-138.68699,58.2208986,13.719616,889169.872638316,1016371.78967583,164.668518066406,143,2.21661057708761,0.355946179433208 +-138.62545,58.2133073,13.719616,892873.947280241,1016371.80864189,157.515396118164,143,2.19732300969624,0.285888229447905 +-138.56394,58.2056861,13.719616,896577.842630019,1016371.78952203,156.728302001953,143,2.19514742846232,0.277985897433612 +-138.50246,58.1980349,13.719616,900281.566762525,1016371.72004802,159.937393188477,143,2.20395001319502,0.309959397690619 +-138.441,58.1903539,13.719616,903985.690341422,1016371.75669609,161.830520629883,143,2.20906043131301,0.328521894953708 +-138.37957,58.1826429,13.719616,907689.65368787,1016371.74134974,160.093154907227,143,2.20437276321491,0.311494946427727 +-138.31816,58.1749021,13.719616,911394.027413587,1016371.83161448,149.668426513672,143,2.17513019288065,0.205277584313146 +-138.25679,58.1671315,13.719616,915097.676284695,1016371.7522193,143.761108398438,143,2.15764141252516,0.141753342267113 +-138.19544,58.159331,13.719616,918801.749038099,1016371.7659881,92.2340393066406,143,1.96489122858976,-0.558370342166111 +-138.13412,58.1515007,13.719616,922505.678149986,1016371.74521347,151.432754516602,143,2.18021982210778,0.223764570390866 +-138.07282,58.1436407,13.719616,926210.03672197,1016371.83889114,147.717391967773,143,2.16943163133743,0.184578782256773 +-138.01156,58.1357509,13.719616,929913.692130343,1016371.75647696,153.641479492188,143,2.1865084805564,0.246606772838091 +-137.95032,58.1278313,13.719616,933617.790454379,1016371.77616101,154.578231811523,143,2.1891483351854,0.256195478340134 +-137.88911,58.119882,13.719616,937321.764076432,1016371.76803368,162.320419311523,143,2.21037315591074,0.333290085381542 +-137.82793,58.111903,13.719616,941025.618362448,1016371.73081031,162.907958984375,143,2.21194230259309,0.338989674010909 +-137.76677,58.1038943,13.719616,944729.929008102,1016371.80547254,161.993240356445,143,2.20949689270841,0.330107247320263 +-137.70565,58.095856,13.719616,948433.557982215,1016371.717644,159.42707824707,143,2.20256208703832,0.304918053735916 +-137.64455,58.087788,13.719616,952137.65399795,1016371.7402991,156.882415771484,143,2.19557426824353,0.279536301351185 +-137.58348,58.0796904,13.719616,955841.649327895,1016371.74077617,157.409149169922,143,2.19702997146989,0.284823830968396 +-137.52244,58.0715632,13.719616,959545.549278088,1016371.71783961,148.725372314453,143,2.17238506479761,0.195306495577964 +-137.46142,58.0634064,13.719616,963249.929484237,1016371.81530866,142.697540283203,143,2.15441648712559,0.130039492730508 +-137.40044,58.05522,13.719616,966953.65456887,1016371.74244073,138.350570678711,143,2.1409809548908,0.0812378047710812 +-137.33948,58.0470041,13.719616,970657.86771795,1016371.79950071,142.819717407227,143,2.1547881694151,0.131389548894706 +-137.27855,58.0387586,13.719616,974362.006631053,1016371.82942698,146.397064208984,143,2.16553236763342,0.170415543523142 +-137.21765,58.0304837,13.719616,978066.070997596,1016371.85267321,154.664642333984,143,2.18939104159642,0.257077057300294 +-137.15678,58.0221792,13.719616,981770.071633836,1016371.84642677,243.453948974609,240,2.3864168234659,0.972730933807227 +-137.09594,58.0138453,13.719616,985474.0081774,1016371.83115283,357.305297851562,340,2.55303945563889,1.57795189269359 +-137.03513,58.005482,13.719616,989177.885826295,1016371.80568885,423.287475585938,340,2.62663541856996,1.84527343643843 +-136.97435,57.9970892,13.719616,992881.712605114,1016371.75807704,434.866668701172,350,2.63835612149863,1.88784637489706 +-136.91359,57.988667,13.719616,996586.061222421,1016371.84805128,432.923431396484,350,2.63641109205203,1.88078147278031 +-136.85287,57.9802154,13.719616,1000289.79618647,1016371.77491286,400.383911132812,350,2.60247661764188,1.75752177585936 +-136.79217,57.9717345,13.719616,1003994.06047992,1016371.84902495,335.624694824219,350,2.52585390814987,1.47920622468572 +-136.73151,57.9632242,13.719616,1007697.72144127,1016371.75667598,124.325408935547,250,2.09455989640343,-0.0873767295442822 +-136.67087,57.9546846,13.719616,1011401.92202118,1016371.81047615,111.19197845459,150,2.04607345776254,-0.263493314095418 +-136.61027,57.9461157,13.71923749,1015105.52667373,1016371.70529971,68.9715270996094,50,1.83866984181599,-1.01684244609902 +-153.60705,59.1084562,13.719616,22433.5197236892,1012667.77334571,16.0844974517822,32,1.20640749624032,-3.31339975087012 +-153.54217,59.108244,13.719616,26137.6286423493,1012667.7765666,32.9000015258789,32,1.51719591809225,-2.18452749485674 +-153.47729,59.1079994,13.719616,29841.7874747553,1012667.77662064,38.4000015258789,32,1.58433124162484,-1.94067283745725 +-153.41241,59.1077224,13.719616,33546.0033008579,1012667.77363977,27.3960151672363,32,1.43768739797607,-2.47332513390971 +-153.34754,59.1074131,13.719616,37249.712197066,1012667.77334339,36.3394966125488,32,1.56037890701421,-2.02767455343999 +-153.28266,59.1070714,13.719616,40954.0631176787,1012667.7753794,45.6826362609863,32,1.65975115829741,-1.66672617311509 +-153.21779,59.1066974,13.719616,44657.9212232234,1012667.77933514,74.8325271606445,32,1.87409041197955,-0.888184825227698 +-153.15292,59.106291,13.719616,48361.8645957302,1012667.77984237,93.1451263427734,32,1.96916013612101,-0.54286445154508 +-153.08805,59.1058522,13.719616,52065.9003135722,1012667.77712026,119.308120727539,132,2.07667000500421,-0.152357921389628 +-153.02318,59.1053811,13.719616,55770.0352902848,1012667.78258381,132.2626953125,132,2.12143736871893,0.0102499214999621 +-152.95832,59.1048776,13.719616,59473.7058525393,1012667.77635305,141.139495849609,132,2.14964856180065,0.112721027048969 +-152.89345,59.1043417,13.719616,63178.0608642781,1012667.77605262,144.598861694336,132,2.16016487413545,0.150919275103337 +-152.82859,59.1037735,13.719616,66881.9654179839,1012667.77468069,145.199661254883,132,2.16196560317326,0.157460036947883 +-152.76373,59.103173,13.719616,70585.9974503639,1012667.78149852,148.105102539062,132,2.17057002115716,0.188713739010836 +-152.69888,59.1025401,13.719616,74289.5933296975,1012667.77446562,140.450149536133,132,2.14752220592765,0.104997495595825 +-152.63402,59.1018748,13.719616,77993.9019177345,1012667.7757382,142.139404296875,132,2.15271449099158,0.123857356973718 +-152.56917,59.1011772,13.719616,81697.7882609656,1012667.77392142,124.950408935547,132,2.0967376818163,-0.0794663913229171 +-152.50432,59.1004473,13.719616,85401.8302936731,1012667.78057704,122.141456604004,132,2.08686309489113,-0.11533370952283 +-152.43947,59.099685,13.719616,89106.0353186687,1012667.78492143,129.601776123047,132,2.11261095334903,-0.0218101384332853 +-152.37463,59.0988903,13.719616,92809.8395146721,1012667.77339045,117.20133972168,132,2.06893257610534,-0.180462471632407 +-152.30979,59.0980634,13.719616,96513.8202775492,1012667.78162376,94.0828018188477,132,1.97351024236669,-0.52706362401682 +-152.24495,59.097204,13.719616,100217.985498681,1012667.7765387,119.740676879883,132,2.07824170883194,-0.146649044478386 +-152.18012,59.0963124,13.719616,103921.770468222,1012667.77647683,149.112167358398,132,2.17351308276227,0.199403778794003 +-152.11529,59.0953884,13.719616,107625.75371758,1012667.77409975,172.872329711914,132,2.23772548480016,0.432641551039856 +-152.05046,59.0944321,13.719616,111329.941986717,1012667.78107999,191.934677124023,132,2.28315344645546,0.597648874203084 +-151.98564,59.0934435,13.719616,115033.771416655,1012667.78061041,187.14469909668,132,2.27217753016449,0.55778121339588 +-151.92082,59.0924225,13.719616,118737.820284316,1012667.7782547,107.157585144043,132,2.03002291797804,-0.321793455872901 +-151.85601,59.0913692,13.719616,122441.524400685,1012667.76729958,80.6664047241211,33,1.90669270100804,-0.769764005856496 +-151.79119,59.0902836,13.71087734,126146.032584218,1012667.78462753,47.8337478637695,33,1.67973440999148,-1.59414129917431 +-151.72639,59.0891657,12.96774834,129849.639185121,1012667.77383812,50.0619010925293,33,1.69950733784748,-1.52232038144584 +-151.66158,59.0880154,12.13343761,133554.064306768,1012667.78134397,35.2891120910645,33,1.54764073121907,-2.07394324376531 +-151.59679,59.0868329,13.719616,137257.601521,1012667.76977815,53.6831321716309,33,1.72983784704863,-1.41215131483802 +-151.53199,59.085618,13.719616,140961.971333438,1012667.77776224,56.546012878418,33,1.75240198775929,-1.33019191532995 +-151.4672,59.0843709,13.719616,144666.038163498,1012667.78639932,47.3826637268066,33,1.67561947194891,-1.60908792866517 +-151.40242,59.0830914,13.719616,148369.80987773,1012667.77234341,57.7577667236328,33,1.76161039234632,-1.29674436152954 +-151.33764,59.0817797,13.719616,152073.863529894,1012667.77984971,52.7168922424316,33,1.72194979988365,-1.44080295361405 +-151.27287,59.0804357,13.719616,155777.635675285,1012667.77499507,71.2737579345703,33,1.85292965773369,-0.965046724529253 +-151.2081,59.0790593,13.719616,159481.704698395,1012667.76967315,76.5661392211914,33,1.88403674873681,-0.85205689115818 +-151.14334,59.0776507,13.719616,163185.505796899,1012667.76239052,91.2659149169922,132,1.96030861184588,-0.575015714188929 +-151.07858,59.0762098,13.719616,166889.617341753,1012667.76619035,110.304229736328,132,2.04259216625639,-0.276138358505282 +-151.01382,59.0747366,13.719616,170594.046350158,1012667.78184641,173.754623413086,132,2.23993636949856,0.440672115313776 +-150.94908,59.0732312,13.719616,174297.657537629,1012667.76882662,201.716857910156,133,2.30474219465015,0.676065369688416 +-150.88434,59.0716935,13.719616,178001.600197053,1012667.76703029,196.789962768555,133,2.29400294355977,0.637057344440728 +-150.8196,59.0701235,13.719616,181705.881341352,1012667.77728285,187.019470214844,133,2.27188682240118,0.556725279823254 +-150.75487,59.0685213,13.719616,185409.936542456,1012667.78367436,181.314407348633,133,2.25843231475966,0.50785466777044 +-150.69015,59.0668868,13.719616,189113.773334561,1012667.77422443,144.040893554688,133,2.15848580684439,0.144820423448683 +-150.62543,59.0652201,13.719616,192817.96905166,1012667.78833569,105.144729614258,133,2.02178750853152,-0.351706813602534 +-150.56072,59.0635211,13.719616,196521.960353141,1012667.78614463,104.309982299805,133,2.01832587170819,-0.364280466594392 +-150.49602,59.0617899,13.719616,200225.753654609,1012667.77805311,111.677032470703,133,2.04796386517592,-0.256626814794026 +-150.43132,59.0600264,13.719616,203929.927420848,1012667.7828588,128.371551513672,133,2.10846879016951,-0.0368556573923673 +-150.36663,59.0582307,13.719616,207633.917148959,1012667.78140492,151.666198730469,133,2.18088880200939,0.226194496339408 +-150.30195,59.0564028,13.719616,211337.729806474,1012667.77297927,176.926162719727,133,2.24779205837424,0.46920621954708 +-150.23727,59.0545427,13.719616,215041.943252657,1012667.78926714,173.176727294922,133,2.23848952805949,0.435416774237398 +-150.1726,59.0526503,13.719616,218745.994202033,1012667.78716491,184.188125610352,133,2.26526162831398,0.53266068387992 +-150.10794,59.0507257,13.719616,222449.888994686,1012667.7771735,191.743576049805,133,2.28272082277562,0.5960774615148 +-150.04329,59.048769,13.719616,226153.633925413,1012667.76980838,199.662963867188,230,2.30029751364481,0.65992101963876 +-149.97864,59.04678,13.719616,229857.808166699,1012667.77673473,204.78742980957,230,2.31130329540983,0.699897160372188 +-149.914,59.0447588,13.719616,233561.847127039,1012667.77500684,210.07470703125,230,2.32237376655158,0.740108271386046 +-149.84937,59.0427055,13.719616,237265.75706301,1012667.77518926,218.637023925781,230,2.33972370713408,0.803128207747757 +-149.78475,59.04062,13.719616,240969.545604015,1012667.76554751,222.386596679688,230,2.34710860861387,0.829952277783104 +-149.72013,59.0385022,13.719616,244673.791314355,1012667.77120922,224.934875488281,230,2.35205679673338,0.847925509386681 +-149.65552,59.0363524,13.719616,248377.928089678,1012667.78937351,224.203582763672,230,2.35064254832167,0.842788555488645 +-149.59092,59.0341703,13.719616,252081.965036697,1012667.78604783,225.998077392578,230,2.35410474453968,0.855364240361636 +-149.52633,59.0319561,13.719616,255785.907627808,1012667.78303401,225.287673950195,230,2.35273743104095,0.850397767464139 +-149.46175,59.0297097,13.719616,259489.763536554,1012667.76868595,218.338790893555,230,2.33913090096067,0.800974966522212 +-149.39718,59.0274312,13.719616,263193.538929378,1012667.75368195,223.443771362305,230,2.34916825292932,0.837433493817854 +-149.33261,59.0251206,13.719616,266897.811605684,1012667.77775143,231.214920043945,230,2.36401585519696,0.891364223181531 +-149.26805,59.0227778,13.719616,270602.018371668,1012667.79022807,214.885620117188,133,2.33220735400839,0.775826667814487 +-149.20351,59.0204029,13.719616,274305.594461296,1012667.76053425,193.091903686523,133,2.2857640642611,0.607131383217686 +-149.13897,59.0179959,13.719616,278009.688560812,1012667.77031201,184.174346923828,133,2.26522913853571,0.532542671731737 +-149.07444,59.0155567,13.719616,281713.737502235,1012667.76727474,184.162124633789,133,2.26520031666478,0.532437982469916 +-149.00992,59.0130855,13.719616,285417.74653449,1012667.77334471,186.448425292969,133,2.27055871974633,0.551901231902637 +-148.94541,59.0105821,13.719616,289121.72421762,1012667.76586804,199.294235229492,230,2.29949473651168,0.657005103955808 +-148.88091,59.0080467,13.719616,292825.675752573,1012667.76679727,208.575653076172,230,2.31926361208774,0.728811302646917 +-148.81642,59.0054792,13.719616,296529.608866315,1012667.76466037,224.898513793945,230,2.35198658547911,0.847670482070884 +-148.75194,59.0028796,13.719616,300233.530444219,1012667.75914941,239.938934326172,230,2.38010072562956,0.949789063671838 +-148.68746,59.0002479,13.719616,303938.018262666,1012667.79573943,245.288482666016,230,2.38967715671831,0.984573394771732 +-148.623,58.9975841,13.719616,307641.93741524,1012667.78318149,247.189453125,230,2.39302993669457,0.996751648624181 +-148.55855,58.9948883,13.719616,311345.864758439,1012667.77756769,242.765975952148,230,2.3851878195875,0.968266840928217 +-148.49411,58.9921605,13.719616,315049.807135286,1012667.77865437,234.078903198242,230,2.36936227385272,0.910783941759045 +-148.42968,58.9894006,13.719616,318753.772322813,1012667.77507503,232.682647705078,230,2.36676399700858,0.901346258639099 +-148.36526,58.9866087,13.719616,322457.766244001,1012667.77776062,241.438568115234,230,2.38280664679576,0.959617741694254 +-148.30085,58.9837847,13.719616,326161.796692316,1012667.7753798,249.748626708984,230,2.39750310885257,1.0129994866725 +-148.23645,58.9809287,13.719616,329865.869563892,1012667.77889495,256.506408691406,230,2.40909822022579,1.05511624075429 +-148.17206,58.9780407,13.719616,333569.991688755,1012667.78814558,218.704513549805,134,2.3398577459528,0.803615074995863 +-148.10769,58.9751208,13.719616,337273.598010267,1012667.7633367,174.077865600586,230,2.24074355308949,0.443604036509152 +-148.04332,58.9721688,13.719616,340977.839110211,1012667.7830843,298.210205078125,230,2.47452250140162,1.29275590393392 +-147.97897,58.9691848,13.719616,344681.579043839,1012667.75628396,456.76220703125,330,2.65969016275795,1.96533770209253 +-139.13256,58.2408761,11.39423658,863242.057586122,1012667.83545188,679.300476074219,440,2.83206191895748,2.59144112040667 +-139.07089,58.2335016,13.719616,866946.057212032,1012667.84159214,229.423355102539,241,2.36063762662482,0.879093532765067 +-139.00925,58.226097,13.719616,870649.840074032,1012667.7915477,182.060577392578,143,2.26021591573239,0.514333215593798 +-138.94763,58.2186623,13.719616,874353.982656693,1012667.81550157,255.7646484375,143,2.40784051649326,1.05054790181337 +-138.88604,58.2111977,13.719616,878057.914610111,1012667.80321857,217.298553466797,143,2.33705683527828,0.793441367966509 +-138.82448,58.2037031,13.719616,881761.643984333,1012667.74235112,207.438873291016,143,2.31689014488729,0.720190192319912 +-138.76294,58.1961785,13.719616,885465.747216333,1012667.76478451,170.880737304688,143,2.23269310921706,0.414362526539057 +-138.70143,58.188624,13.719616,889169.656399277,1012667.74774714,170.120407104492,143,2.23075641332616,0.40732789427524 +-138.63994,58.1810395,13.719616,892873.950489488,1012667.81338116,162.758850097656,143,2.21154461287204,0.337545151432103 +-138.57848,58.1734251,13.719616,896578.061548367,1012667.83781856,170.673599243164,143,2.23216634718529,0.412449176486805 +-138.51705,58.1657808,13.719616,900281.995065977,1012667.81965408,171.517318725586,143,2.23430797888147,0.420228194089879 +-138.45565,58.1581067,13.719616,903985.753935234,1012667.76836232,170.624267578125,143,2.23204080013597,0.411993153768991 +-138.39427,58.1504027,13.719616,907689.917099145,1012667.80836633,162.934677124023,143,2.21201352433854,0.339248371719077 +-138.33292,58.1426688,13.719616,911393.919136736,1012667.80273427,167.329986572266,143,2.22357377620385,0.381238506118274 +-138.2716,58.1349052,13.719616,915097.760271872,1012667.77182923,163.071533203125,143,2.21237815446874,0.340572812427794 +-138.2103,58.1271117,13.719616,918802.022061291,1012667.83092455,153.81462097168,143,2.18699761963653,0.248383465591319 +-138.14904,58.1192885,13.719616,922505.562890114,1012667.72425301,140.717864990234,143,2.14834923726525,0.108001509472245 +-138.0878,58.1114355,13.719616,926209.532585384,1012667.71688272,149.044586181641,143,2.1733162055673,0.198688664627528 +-138.02658,58.1035527,13.719616,929913.936559941,1012667.80916798,155.642059326172,143,2.1921269683928,0.26701472433597 +-137.9654,58.0956403,13.719616,933617.633091163,1012667.74200733,159.880447387695,143,2.20379535486037,0.309397634475268 +-137.90424,58.0876981,13.719616,937321.774669577,1012667.77300438,169.018112182617,143,2.22793324662246,0.397073346995411 +-137.84311,58.0797262,13.719616,941025.79310543,1012667.77169378,169.826416015625,143,2.23000524443284,0.404599434449778 +-137.78201,58.0717247,13.719616,944729.691056563,1012667.74763539,166.605621337891,143,2.22168965058122,0.374394824073893 +-137.72093,58.0636936,13.719616,948434.044739616,1012667.84236502,166.413726806641,143,2.22118914665724,0.372576850963969 +-137.65989,58.0556328,13.719616,952137.720406034,1012667.75871431,161.080764770508,143,2.20704368286005,0.321196488935218 +-137.59887,58.0475424,13.719616,955841.862452696,1012667.79245251,162.704452514648,143,2.2113994378544,0.337017834330955 +-137.53788,58.0394224,13.719616,959545.905291356,1012667.79952403,162.892868041992,143,2.21190206995729,0.338843537594153 +-137.47692,58.0312729,13.719616,963249.851470296,1012667.78952466,160.454772949219,143,2.2053526403139,0.315054139736023 +-137.41599,58.0230938,13.719616,966953.709013691,1012667.75040116,151.936325073242,143,2.18166161779215,0.229001583845958 +-137.35508,58.0148852,13.719616,970658.051331348,1012667.83792551,153.018417358398,143,2.1847437058225,0.240196607287702 +-137.29421,58.0066471,13.719616,974361.741887668,1012667.7591312,152.85969543457,143,2.18429298993941,0.238559478553201 +-137.23336,57.9983795,13.719616,978065.927714761,1012667.80569906,165.647735595703,143,2.21918550345364,0.365299046951782 +-137.17254,57.9900825,13.719616,981770.040357944,1012667.84110044,292.437927246094,240,2.46603369703247,1.26192214351915 +-137.11176,57.981756,13.719616,985473.516937458,1012667.70495254,378.967651367188,340,2.57860214022582,1.67080285942993 +-137.05099,57.9734001,13.719616,989178.072540458,1012667.85207248,430.519165039062,340,2.63399248932149,1.87199641732506 +-136.99026,57.9650147,13.719616,992882.002507851,1012667.82532456,439.189117431641,350,2.64265157029007,1.90344867095071 +-136.92956,57.9566,13.719616,996585.877268056,1012667.79356618,446.005401611328,350,2.64934011852332,1.92774338723562 +-136.86889,57.948156,13.719616,1000289.70197051,1012667.75565188,424.021575927734,350,2.6273879558096,1.84800686648834 +-136.80824,57.9396826,13.719616,1003994.05551155,1012667.85082717,230.861694335938,250,2.3633518787006,0.888952471028959 +-136.74763,57.9311798,13.719616,1007697.80127102,1012667.7761764,129.052734375,150,2.11076721082792,-0.028507137526459 +-136.68705,57.9226478,13.719616,1011401.50954448,1012667.70280157,121.250396728516,150,2.0836831682782,-0.126884110622401 +-136.62649,57.9140865,13.719616,1015105.75920986,1012667.77165343,101.520324707031,150,2.00655299815527,-0.407042903651245 +-136.56596,57.9054959,12.28784804,1018809.98449246,1012667.82990353,35.0585060119629,50,1.54479340506682,-2.08428554505809 +-153.60743,59.0753245,13.719616,22433.7204002281,1008963.7746886,14.4672145843506,32,1.16038492316523,-3.48056687242902 +-153.54261,59.0751125,13.719616,26138.0189244255,1008963.77902721,29.2793102264404,32,1.46656084122586,-2.36844854672528 +-153.4778,59.0748681,13.719616,29841.7958418541,1008963.7726064,38.4000015258789,32,1.58433124162484,-1.94067283745725 +-153.41299,59.0745914,13.719616,33545.6295811796,1008963.77011476,52.9313507080078,32,1.72371297650685,-1.43439859285787 +-153.34818,59.0742824,13.719616,37249.5271857236,1008963.7717011,54.4507522583008,32,1.73600388408026,-1.38975450837695 +-153.28336,59.0739411,13.719616,40954.067149705,1008963.78369827,56.7143325805664,32,1.75369282563125,-1.32550322373718 +-153.21856,59.0735674,13.719616,44657.5422938385,1008963.77661118,79.1688003540039,32,1.8985540641189,-0.799325858036092 +-153.15375,59.0731613,13.719616,48361.6740467794,1008963.76914125,105.452308654785,132,2.02305609213675,-0.347098955858514 +-153.08894,59.072723,13.719616,52065.8977253604,1008963.77769709,131.771728515625,132,2.11982224283237,0.00438332327715634 +-153.02414,59.0722523,13.719616,55769.6492158036,1008963.77176004,140.709838867188,132,2.14832446571005,0.10791153211323 +-152.95934,59.0717493,13.719616,59473.5068680011,1008963.7700438,145.576446533203,132,2.16309111420693,0.161548214275031 +-152.89453,59.071214,13.719616,63178.0491738301,1008963.78233192,146.822891235352,132,2.16679377194355,0.174997324018157 +-152.82974,59.0706463,13.719616,66881.5690169233,1008963.76919524,149.107955932617,132,2.17350081666193,0.199359224816474 +-152.76494,59.0700463,13.719616,70585.787615318,1008963.77065627,155.814514160156,132,2.1926079098582,0.268761641012678 +-152.70015,59.069414,13.719616,74289.5691057496,1008963.7663381,147.451919555664,132,2.16865043064846,0.181741238377528 +-152.63535,59.0687494,13.719616,77994.0634290958,1008963.77839557,139.106796264648,132,2.14334834859831,0.0898368544381782 +-152.57057,59.0680525,13.719616,81697.5632696884,1008963.77195363,133.09944152832,132,2.12417623322315,0.0201982591290681 +-152.50578,59.0673232,13.719616,85401.7902698245,1008963.7714427,129.240859985352,132,2.11139983920672,-0.0262092506845373 +-152.441,59.0665617,13.719616,89105.6080715659,1008963.77444646,142.793502807617,132,2.15470844722312,0.13109997513844 +-152.37622,59.0657678,13.719616,92809.5956758456,1008963.77132338,111.616760253906,132,2.04772941269533,-0.25747841312294 +-152.31144,59.0649416,13.719616,96513.7598662383,1008963.77367653,122.926559448242,132,2.08964572646369,-0.105226397409183 +-152.24667,59.0640831,13.719616,100217.536225865,1008963.76685933,110.908393859863,132,2.04496441602355,-0.267521670243468 +-152.18189,59.0631923,13.719616,103922.074690587,1008963.78095637,148.331298828125,132,2.17123279953917,0.191121139270061 +-152.11713,59.0622692,13.719616,107625.667939509,1008963.76950147,169.551895141602,132,2.22930264840452,0.402047405134048 +-152.05236,59.0613138,13.719616,111330.037357966,1008963.77993531,191.45654296875,132,2.2820702128183,0.593714260447255 +-151.9876,59.0603261,13.719616,115034.047074472,1008963.77980138,197.897994995117,132,2.29644139417119,0.645914493064484 +-151.92285,59.0593061,13.719616,118737.704118974,1008963.767957,198.325729370117,132,2.29737906013878,0.649320363495279 +-151.8581,59.0582539,13.719616,122441.586611152,1008963.77288716,134.628189086914,33,2.12913600404193,0.038213562402412 +-151.79335,59.0571693,13.719616,126145.702289086,1008963.77280977,193.404434204102,33,2.28646642697706,0.609682565076318 +-151.7286,59.0560524,13.719616,129850.057830144,1008963.77948104,175.32014465332,33,2.2438318203102,0.454821504533986 +-151.66387,59.0549033,13.719616,133553.516964697,1008963.7644526,144.473480224609,33,2.15978813464188,0.149550849730533 +-151.59913,59.0537219,13.719616,137257.801442506,1008963.77582565,132.580169677734,33,2.12247857049729,0.0140318635475685 +-151.5344,59.0525082,13.719616,140961.775384909,1008963.77345634,96.3677215576172,33,1.98393159098916,-0.489210311270978 +-151.46967,59.0512623,13.719616,144666.01683981,1008963.78927741,70.7213516235352,33,1.84955055230244,-0.977320599948283 +-151.40495,59.049984,13.719616,148369.962218186,1008963.77927389,58.1074371337891,33,1.76423172102131,-1.28722294758025 +-151.34024,59.0486735,13.719616,152073.617677651,1008963.76480027,69.2988739013672,33,1.84072617743438,-1.00937324819642 +-151.27553,59.0473308,13.719616,155777.561655657,1008963.76834186,69.5766143798828,33,1.84246329201852,-1.00306355220493 +-151.21082,59.0459558,13.719616,159481.801606585,1008963.77944843,89.6897201538086,33,1.95274266894916,-0.602497378324914 +-151.14612,59.0445485,13.719616,163185.773095609,1008963.77428558,108.51114654541,33,2.0354743523276,-0.301992290320999 +-151.08142,59.043109,13.719616,166890.054097793,1008963.78823316,126.895118713379,132,2.1034449163688,-0.0551038009928814 +-151.01674,59.0416372,13.719616,170593.50919381,1008963.75951882,153.747451782227,132,2.18680792648915,0.247694445936233 +-150.95205,59.0401332,13.719616,174297.859236583,1008963.77548867,156.035949707031,133,2.19322466861543,0.271001884859401 +-150.88737,59.038597,13.719616,178001.968301956,1008963.78501484,160.924728393555,133,2.20662278480564,0.319667667065335 +-150.8227,59.0370285,13.719616,181705.843901332,1008963.77607989,164.005020141602,133,2.21485714186738,0.349577202233084 +-150.75803,59.0354278,13.719616,185410.063948285,1008963.78693573,160.777572631836,133,2.20622546753716,0.318224497340608 +-150.69337,59.0337949,13.719616,189114.063965399,1008963.78996248,127.925430297852,133,2.10695688646626,-0.0423473231828365 +-150.62872,59.0321298,13.719616,192817.850924908,1008963.78436039,110.496047973633,133,2.04334674522532,-0.273397512311842 +-150.56407,59.0304324,13.719616,196522.003826769,1008963.7877745,109.179664611816,133,2.03814175586607,-0.292303519316528 +-150.49943,59.0287028,13.719616,200225.957632474,1008963.78212827,115.8349609375,133,2.06383965654784,-0.198961409129214 +-150.4348,59.026941,13.719616,203929.719309445,1008963.76667327,121.146728515625,133,2.08331169080704,-0.128233422827914 +-150.37017,59.0251471,13.719616,207633.866663918,1008963.78310549,132.262466430664,133,2.1214366171676,0.0102471916510236 +-150.30555,59.0233209,13.719616,211337.836419332,1008963.77823587,156.160446166992,133,2.19357104114988,0.272260008769111 +-150.24094,59.0214625,13.719616,215041.634938192,1008963.76253016,168.556488037109,133,2.22674547394085,0.39275901759174 +-150.17633,59.019572,13.719616,218745.839988982,1008963.77940682,184.68701171875,133,2.26643635436165,0.53692762418522 +-150.11173,59.0176493,13.719616,222449.887700908,1008963.78521831,196.675872802734,230,2.29375108614545,0.636142526424659 +-150.04714,59.0156944,13.719616,226153.785030965,1008963.77931851,203.437042236328,230,2.30843003302206,0.689460651269059 +-149.98256,59.0137073,13.719616,229857.538934315,1008963.76107833,207.771362304688,230,2.31758568734948,0.722716601070158 +-149.91798,59.0116881,13.719616,233561.727128725,1008963.77621262,210.740798950195,230,2.3237486221941,0.745102139502568 +-149.85341,59.0096367,13.719616,237265.785779392,1008963.77891347,221.10758972168,230,2.3446036503927,0.820853554537552 +-149.78885,59.0075531,13.719616,240969.721835758,1008963.76860275,224.642364501953,230,2.35149166169591,0.845872777624983 +-149.7243,59.0054374,13.719616,244673.54152608,1008963.75587509,228.293472290039,230,2.35849349366743,0.871305429867366 +-149.65975,59.0032896,13.719616,248377.823214506,1008963.77758422,233.927139282227,230,2.36908060982446,0.90976085761348 +-149.59521,59.0011096,13.719616,252082.003101707,1008963.78576185,231.151824951172,230,2.36389732655669,0.890933693328603 +-149.53069,58.9988975,13.719616,255785.515926175,1008963.75253565,233.420257568359,230,2.3681385439475,0.906339005456004 +-149.46617,58.9966533,13.719616,259489.5114971,1008963.75388337,237.148635864258,230,2.37502063082922,0.931336709353559 +-149.40165,58.994377,13.719616,263193.996719209,1008963.79099944,240.409942626953,230,2.38095242480628,0.952882678180828 +-149.33715,58.9920685,13.719616,266897.836376964,1008963.77356638,231.961135864258,230,2.36541522672893,0.896447140006017 +-149.27266,58.989728,13.719616,270601.607264319,1008963.76251575,221.073623657227,230,2.34453692989917,0.82061120666113 +-149.20817,58.9873554,13.719616,274305.888504104,1008963.78757149,215.833587646484,230,2.33411902975594,0.782770419776187 +-149.1437,58.9849506,13.719616,278009.544906679,1008963.75512255,213.676544189453,230,2.32975685118522,0.766925742117601 +-149.07923,58.9825138,13.719616,281713.724645555,1008963.77023916,200.365463256836,230,2.30182286485192,0.665461530601574 +-149.01477,58.9800449,13.719616,285417.863966914,1008963.78008955,203.332733154297,230,2.30820729838211,0.688651615481976 +-148.95032,58.9775439,13.719616,289121.969759919,1008963.78431271,219.18505859375,230,2.34081094583673,0.80707736904463 +-148.88588,58.9750109,13.719616,292826.048051403,1008963.79370996,230.791748046875,230,2.36322027657306,0.888474454538747 +-148.82146,58.9724458,13.719616,296529.535112992,1008963.75215583,251.514343261719,230,2.40056275687423,1.02411300159766 +-148.75704,58.9698487,13.719616,300233.5798475,1008963.75922699,256.463287353516,230,2.40902520476586,1.05485102776315 +-148.69263,58.9672195,13.719616,303937.618543355,1008963.75939085,254.190841674805,230,2.40515989916155,1.04081113454024 +-148.62823,58.9645583,13.719616,307641.657174509,1008963.76351216,242.617218017578,230,2.38492161856138,0.967299922820044 +-148.56384,58.9618651,13.719616,311345.702583233,1008963.77132756,241.387573242188,230,2.38271490863101,0.959284522495185 +-148.49946,58.9591398,13.719616,315049.762534112,1008963.77145004,246.868469238281,230,2.39246562411467,0.994701904263124 +-148.43509,58.9563825,13.719616,318753.842961151,1008963.77479164,251.988250732422,230,2.40138029172983,1.02708252154086 +-148.37073,58.9535933,13.719616,322457.9497526,1008963.79227737,262.697021484375,230,2.41945514868925,1.0927355610953 +-148.30639,58.950772,13.719616,326161.520171373,1008963.75231991,266.436553955078,230,2.42559380793043,1.11503292360703 +-148.24205,58.9479187,13.719616,329865.70301366,1008963.76354577,266.879913330078,230,2.42631588791944,1.11765572422928 +-148.17772,58.9450335,13.719616,333569.932676303,1008963.78837199,265.155914306641,330,2.42350131850754,1.10743240476716 +-148.11341,58.9421163,13.719616,337273.64548943,1008963.76472807,268.893981933594,330,2.42958108246771,1.12951584280789 +-148.0491,58.9391671,13.719616,340977.991176817,1008963.79349717,411.4755859375,330,2.61434407233767,1.80062775862327 +-147.98481,58.936186,13.719616,344681.832643657,1008963.78356847,582.601745605469,430,2.76537178153725,2.34920350603606 +-138.90029,58.1789002,12.06650704,878057.795175884,1008963.77073554,672.833435058594,440,2.82790756468738,2.57635131992692 +-138.83878,58.1714124,13.719616,881761.749132211,1008963.76695283,469.602630615234,241,2.67173052107278,2.00907172015238 +-138.77729,58.1638946,13.719616,885466.073767544,1008963.84337843,329.326446533203,241,2.51762660809499,1.44932232258116 +-138.71584,58.1563468,13.719616,889169.631716066,1008963.73246705,165.63395690918,143,2.21914937705328,0.365167825554157 +-138.65441,58.1487692,13.719616,892873.5662934,1008963.72176099,176.193832397461,143,2.24599070201797,0.462663179102819 +-138.593,58.1411617,13.719616,896577.885532964,1008963.80062874,179.476806640625,143,2.25400833370095,0.491785505835298 +-138.53162,58.1335243,13.719616,900282.023472519,1008963.83376912,184.543365478516,143,2.26609843648446,0.53570021000392 +-138.47027,58.125857,13.719616,903985.98559519,1008963.81978158,181.347320556641,143,2.258511143175,0.508140995074848 +-138.40895,58.1181599,13.719616,907689.774779374,1008963.76814322,173.073638916016,143,2.23823092492257,0.434477453831435 +-138.34765,58.110433,13.719616,911393.967917582,1008963.81470498,175.391708374023,143,2.24400905828587,0.455465283450378 +-138.28638,58.1026763,13.719616,915097.998994102,1008963.82197439,171.795227050781,143,2.23501109375423,0.422782107996703 +-138.22514,58.0948899,13.719616,918801.870809662,1008963.79944889,174.354843139648,143,2.24143401548952,0.446111993023657 +-138.16393,58.0870736,13.719616,922505.594035683,1008963.72405989,161.712799072266,143,2.20874439434351,0.327373958474552 +-138.10274,58.0792277,13.719616,926209.737624581,1008963.7665035,158.492126464844,143,2.20000769230894,0.295639762981971 +-138.04158,58.071352,13.719616,929913.740794767,1008963.76538606,153.030685424805,143,2.18477852346123,0.240323074889503 +-137.98045,58.0634466,13.719616,933617.606283375,1008963.73024127,172.363479614258,143,2.23644525289148,0.427991383332987 +-137.91934,58.0555115,13.719616,937321.910911637,1008963.80089788,174.844985961914,143,2.24265318254006,0.450540355736127 +-137.85827,58.0475468,13.719616,941025.514452579,1008963.70517881,170.403854370117,143,2.23147941386226,0.409954038587282 +-137.79722,58.0395525,13.719616,944729.565136846,1008963.72462518,171.89192199707,143,2.23525546764383,0.423669743714984 +-137.73619,58.0315285,13.719616,948434.070995361,1008963.84878785,171.320327758789,143,2.23380889658898,0.418415384751284 +-137.6752,58.0234749,13.719616,952137.891753398,1008963.80216978,170.352508544922,143,2.23134853320296,0.409478642675638 +-137.61424,58.0153917,13.719616,955841.604172487,1008963.72576433,168.550521850586,143,2.22673010148161,0.392703180432023 +-137.5533,58.007279,13.719616,959545.782269783,1008963.77363755,159.666885375977,143,2.20321485358539,0.307289088152986 +-137.49239,57.9991367,13.719616,963249.862610986,1008963.7903443,162.490661621094,143,2.21082840701972,0.334943687350991 +-137.43151,57.9909649,13.719616,966953.8477302,1008963.78548199,158.227172851562,143,2.19928106832803,0.293000457284157 +-137.37066,57.9827636,13.719616,970657.742883978,1008963.75782601,159.108337402344,143,2.20169293761617,0.301761054954702 +-137.30984,57.9745329,13.719616,974361.550544837,1008963.71698297,164.423202514648,143,2.21596310282117,0.353594368089952 +-137.24904,57.9662726,13.719616,978065.852954534,1008963.78738212,180.281967163086,143,2.25595228826854,0.498846503684689 +-137.18828,57.957983,13.719616,981769.504085471,1008963.70629307,330.249298095703,240,2.518841903248,1.45373662145665 +-137.12754,57.9496639,13.719616,985473.657628355,1008963.74600193,396.372344970703,340,2.59810334600094,1.74163680500344 +-137.06683,57.9413154,13.719616,989177.744540751,1008963.76887418,430.460296630859,340,2.63393310062288,1.87178070062047 +-137.00615,57.9329375,13.719616,992881.770013205,1008963.7737432,445.743499755859,340,2.6490850186096,1.92681679153621 +-136.9455,57.9245302,13.719616,996585.739230167,1008963.75945325,444.435913085938,350,2.6478091452843,1.92218245544821 +-136.88488,57.9160936,13.719616,1000289.65452293,1008963.73566097,453.099517822266,350,2.65619360001357,1.95263718818656 +-136.82429,57.9076277,13.719616,1003993.52103421,1008963.70122413,191.133819580078,250,2.28133753874261,0.591052979078364 +-136.76372,57.8991325,13.719616,1007697.91535175,1008963.80674772,147.217254638672,150,2.16795871458844,0.17922872821214 +-136.70319,57.890608,13.719616,1011401.69970367,1008963.74819575,128.008560180664,150,2.10723901273319,-0.0413225600545135 +-136.64268,57.8820543,13.719616,1015106.01923033,1008963.83927952,116.367492675781,150,2.06583167684955,-0.191725822814215 +-136.58221,57.8734713,13.719616,1018809.73901424,1008963.7629571,64.1622772216797,50,1.80727976935433,-1.13086014889844 +-136.52176,57.8648591,13.41496668,1022514.00416384,1008963.83518649,43.1998023986816,50,1.63548176030199,-1.7548795538103 +-153.60781,59.0421922,13.71606807,22433.8787012473,1005259.77389776,14.1490163803101,32,1.15072624936902,-3.51564993251685 +-153.54306,59.0419804,13.719616,26137.7881315433,1005259.77537951,23.8362979888916,32,1.37723880610844,-2.6928916733188 +-153.47831,59.0417363,13.719616,29841.7472491687,1005259.77755381,34.7000007629395,32,1.54032948433959,-2.10049977926921 +-153.41356,59.0414599,13.719616,33545.7630940759,1005259.78055177,41.7496337890625,32,1.62065267038041,-1.80874304104911 +-153.34881,59.0411511,13.719616,37249.8428155832,1005259.77334327,59.8641586303711,32,1.77716688302688,-1.24023874711323 +-153.28406,59.0408101,13.719616,40953.9932447771,1005259.77845144,61.7037734985352,32,1.79031172415447,-1.19249293222664 +-153.21932,59.0404368,13.719616,44657.649510565,1005259.77815626,87.9132308959961,32,1.94405424108864,-0.634056228238514 +-153.15457,59.0400311,13.719616,48361.9628118644,1005259.77437122,112.523246765137,132,2.05124225488171,-0.244718767637001 +-153.08983,59.0395932,13.719616,52065.7958955043,1005259.77566407,133.154357910156,132,2.12435538470934,0.0208489884618109 +-153.02509,59.039123,13.719616,55769.7279398036,1005259.7778161,146.60774230957,132,2.16615690586812,0.172684044652514 +-152.96035,59.0386205,13.719616,59473.7659823117,1005259.78107984,149.886535644531,132,2.17576262178813,0.207574746618296 +-152.89561,59.0380856,13.719616,63177.9172460104,1005259.77454756,153.165664672852,132,2.18516141990252,0.241713864053821 +-152.83088,59.0375185,13.719616,66881.6163976659,1005259.7707909,155.479858398438,132,2.19167413643051,0.265369909397837 +-152.76614,59.0369191,13.719616,70586.0146661779,1005259.77852065,159.205032348633,132,2.20195679133319,0.302719446966268 +-152.70141,59.0362874,13.719616,74289.9750692003,1005259.77735913,155.996551513672,132,2.19311499787282,0.27060352941909 +-152.63669,59.0356234,13.719616,77993.5046416391,1005259.76597232,149.121994018555,132,2.17354170231587,0.199507733181501 +-152.57196,59.0349272,13.719616,81697.7541952521,1005259.77882361,145.793014526367,132,2.16373671585212,0.163893223723399 +-152.50724,59.0341986,13.719616,85401.5872156649,1005259.76988766,144.465377807617,132,2.15976377768959,0.149462378327629 +-152.44252,59.0334378,13.719616,89105.5822531255,1005259.77365241,141.636352539062,132,2.15117473415106,0.118264520638619 +-152.3778,59.0326447,13.719616,92809.7465802294,1005259.77934974,115.253074645996,132,2.06165252003981,-0.206905713197304 +-152.31309,59.0318193,13.719616,96513.5152195458,1005259.77287255,118.860038757324,132,2.07503586753492,-0.158293575107362 +-152.24837,59.0309616,13.719616,100218.039219625,1005259.78317168,135.655731201172,132,2.1324381466156,0.0502078867552901 +-152.18367,59.0300716,13.719616,103921.609583603,1005259.76543582,143.707962036133,132,2.15748083057379,0.141170062785067 +-152.11896,59.0291494,13.719616,107625.949050718,1005259.77658875,176.27360534668,132,2.2461872872825,0.463377232894588 +-152.05426,59.0281949,13.719616,111329.920926137,1005259.77409583,193.029968261719,132,2.2856247392686,0.606625315077593 +-151.98957,59.0272082,13.719616,115033.531898793,1005259.76796989,197.702728271484,132,2.2960126625614,0.644357217485541 +-151.92487,59.0261892,13.719616,118737.933329488,1005259.78165096,196.157089233398,132,2.29260400840902,0.631976012677338 +-151.86018,59.0251379,13.719616,122441.988225786,1005259.78048499,189.165084838867,132,2.27684097952282,0.574720192546285 +-151.7955,59.0240544,13.719616,126145.703241079,1005259.77453555,172.243835449219,132,2.23614368759972,0.426896012117984 +-151.73082,59.0229386,13.719616,129849.657756933,1005259.7710894,152.610870361328,132,2.18358546920079,0.235989561284022 +-151.66614,59.0217906,13.719616,133553.858402901,1005259.78191706,139.770797729492,132,2.14541644387238,0.097348766766768 +-151.60147,59.0206103,13.719616,137257.740562332,1005259.77579339,129.76448059082,132,2.11315583272308,-0.0198309810226766 +-151.5368,59.0193978,13.719616,140961.88284975,1005259.78407499,135.660751342773,132,2.13245421802988,0.0502662627191993 +-151.47214,59.018153,13.719616,144665.720668003,1005259.77445644,140.562606811523,33,2.14786980279403,0.106260066628529 +-151.40748,59.016876,13.719616,148369.832607538,1005259.77944342,134.31135559082,33,2.12811273241516,0.0344967477831767 +-151.34283,59.0155667,13.719616,152073.654090576,1005259.76565029,100.330696105957,33,2.00143382544212,-0.42563720010275 +-151.27818,59.0142253,13.719616,155777.763225339,1005259.7779013,106.404273986816,33,2.026959072805,-0.332922216049859 +-151.21354,59.0128516,13.719616,159481.595889583,1005259.77056008,127.629653930664,132,2.10595159164388,-0.0459988409174253 +-151.1489,59.0114457,13.719616,163185.730625258,1005259.77843021,138.085250854492,132,2.14014729324492,0.0782097077225183 +-151.08427,59.0100075,13.719616,166889.602892953,1005259.76596556,148.251541137695,132,2.17099921673524,0.190272699855027 +-151.01964,59.0085372,13.719616,170593.790708674,1005259.78028628,163.579772949219,132,2.21372960104906,0.345481652148756 +-150.95502,59.0070346,13.719616,174297.730031785,1005259.77359736,159.930038452148,133,2.20393004166252,0.309886855384129 +-150.8904,59.0054998,13.719616,178001.999355261,1005259.78300003,157.619598388672,133,2.19761021659818,0.286931446892763 +-150.82579,59.0039328,13.719616,181706.03364344,1005259.78195386,156.405426025391,133,2.19425181555253,0.274732775711902 +-150.76119,59.0023337,13.719616,185409.839323138,1005259.7807887,154.716110229492,133,2.18953553813045,0.257601909955305 +-150.69659,59.0007023,13.719616,189113.996452626,1005259.78483041,141.926910400391,133,2.1520647487369,0.12149730764983 +-150.632,58.9990388,13.719616,192817.938890923,1005259.78824723,119.734237670898,133,2.07821835345933,-0.146733877858005 +-150.56742,58.997343,13.719616,196521.674727718,1005259.76792512,112.494804382324,133,2.05113246484567,-0.245117556385123 +-150.50284,58.9956151,13.719616,200225.781793275,1005259.7755745,118.586975097656,133,2.07403699127234,-0.161921778800732 +-150.43827,58.993855,13.719616,203929.695609302,1005259.77024649,122.712493896484,133,2.08888878240155,-0.107975834296196 +-150.3737,58.9920627,13.719616,207633.995147008,1005259.78247267,124.681709289551,133,2.09580274748619,-0.0828623396666915 +-150.30915,58.9902383,13.719616,211337.542728194,1005259.76072613,148.141845703125,133,2.17067775123558,0.189105045404856 +-150.24459,58.9883817,13.719616,215042.061937758,1005259.78861282,176.155899047852,133,2.24589719126426,0.462323521354706 +-150.18005,58.986493,13.719616,218745.843063419,1005259.78114272,190.489761352539,133,2.27987163771457,0.585728408134682 +-150.11551,58.9845721,13.719616,222450.037699326,1005259.79180755,204.193801879883,230,2.31004255533063,0.695317792553458 +-150.05099,58.982619,13.719616,226153.508781183,1005259.75352494,208.492050170898,230,2.31908949992017,0.728178877557746 +-149.98646,58.9806339,13.719616,229857.977937112,1005259.79014118,215.569351196289,230,2.33358701461995,0.78083798895002 +-149.92195,58.9786166,13.719616,233561.737397167,1005259.77656167,219.004638671875,230,2.34045331359931,0.805778346679919 +-149.85744,58.9765671,13.719616,237265.938127136,1005259.78196948,214.586669921875,230,2.33160274018734,0.773630537842471 +-149.79294,58.9744856,13.719616,240970.013648736,1005259.79348538,223.951217651367,230,2.35015342810168,0.84101193124084 +-149.72845,58.9723719,13.719616,244673.97227805,1005259.78823047,232.83186340332,230,2.36704241392163,0.902357548335363 +-149.66397,58.9702261,13.719616,248377.820227798,1005259.776813,235.936630249023,230,2.37279537233976,0.923253935367853 +-149.5995,58.9680482,13.719616,252081.564405534,1005259.75870116,237.001770019531,230,2.3747515894989,0.930359474449806 +-149.53503,58.9658382,13.719616,255785.7837257,1005259.77189546,238.595672607422,230,2.37766256263793,0.940932959765199 +-149.47057,58.9635962,13.719616,259489.912320992,1005259.78965038,240.845031738281,230,2.3817376919172,0.955734992465226 +-149.40612,58.961322,13.719616,263193.958605588,1005259.78917852,241.49494934082,230,2.38290805228691,0.959986075382134 +-149.34168,58.9590157,13.719616,266897.928727699,1005259.78116883,237.495025634766,230,2.37565451769985,0.933639167397015 +-149.27725,58.9566774,13.719616,270601.828790095,1005259.77632399,222.358932495117,230,2.34705458040253,0.829756031898342 +-149.21283,58.954307,13.719616,274305.666460301,1005259.76306122,217.72102355957,230,2.33790036737399,0.796505317306154 +-149.14841,58.9519046,13.719616,278010.019823972,1005259.79397718,220.364532470703,230,2.34314169638767,0.815543320308076 +-149.08401,58.9494701,13.719616,281713.752547962,1005259.77435794,244.972702026367,230,2.38911769244686,0.98254126085083 +-149.01961,58.9470035,13.719616,285418.015538245,1005259.78810462,232.981140136719,230,2.36732076623604,0.903368603390993 +-148.95523,58.944505,13.719616,289121.669966122,1005259.77174885,247.850967407227,230,2.39419061837452,1.00096757577729 +-148.89085,58.9419743,13.719616,292825.869245521,1005259.77801476,270.826324462891,230,2.43269087571964,1.14081149952226 +-148.82648,58.9394117,13.719616,296530.045671225,1005259.7970309,277.110473632812,230,2.44265294063238,1.17699656274174 +-148.76213,58.936817,13.719616,300233.635809723,1005259.76098252,278.531463623047,230,2.44487426129091,1.18506503340158 +-148.69778,58.9341903,13.719616,303937.789663634,1005259.77057458,270.617736816406,230,2.43235625770525,1.13959607138452 +-148.63344,58.9315317,13.719616,307641.941163175,1005259.79201541,258.185974121094,230,2.4119326456482,1.06541168291404 +-148.56912,58.928841,13.719616,311345.52693229,1005259.75587222,252.008850097656,230,2.40141579269062,1.02721147116342 +-148.5048,58.9261183,13.719616,315049.696933785,1005259.76624361,261.900909423828,230,2.41813700647053,1.08794769232166 +-148.44049,58.9233637,13.719616,318753.885058009,1005259.78771184,266.052520751953,230,2.42496737806426,1.11275755153224 +-148.3762,58.920577,13.719616,322457.527986047,1005259.74922609,277.961608886719,230,2.44398481678134,1.18183431707009 +-148.31191,58.9177584,13.719616,326161.774684403,1005259.76941579,277.347961425781,330,2.4430249780577,1.17834790886056 +-148.24763,58.9149079,13.719616,329866.059938014,1005259.80009762,277.982482910156,330,2.44401742967653,1.18195277641407 +-148.18337,58.9120254,13.719616,333569.819506997,1005259.77973821,277.118316650391,330,2.44266523223222,1.17704120934074 +-148.11912,58.9091109,13.719616,337273.632221163,1005259.75729969,363.577178955078,330,2.56059661557049,1.60540165459339 +-148.05487,58.9061646,13.719616,340978.07490892,1005259.80625873,499.353637695312,430,2.69840821797573,2.10597272987671 +-147.99064,58.9031862,13.719616,344682.013333607,1005259.79096502,668.109313964844,430,2.82484752619965,2.56523638671755 +-138.73022,58.1240673,13.31959237,889169.795542012,1005259.77789543,533.156921386719,341,2.72685505154482,2.20929974893428 +-138.66884,58.1164965,13.719616,892873.939077893,1005259.81497826,232.001876831055,241,2.36549149822742,0.896724179858613 +-138.60749,58.1088958,13.719616,896577.892088949,1005259.80351429,194.182723999023,143,2.28821058908568,0.616017859688261 +-138.54617,58.1012652,13.719616,900281.660063006,1005259.74208405,186.156158447266,143,2.26987740819032,0.549426513865496 +-138.48487,58.0936048,13.719616,903985.817904603,1005259.77626829,195.150024414062,143,2.29036860994928,0.623856407425326 +-138.4236,58.0859147,13.719616,907689.796454538,1005259.78052561,199.772811889648,143,2.30053638253989,0.660788659645666 +-138.36236,58.0781947,13.719616,911393.606335848,1005259.73172981,184.789886474609,143,2.26667819865648,0.537806071693309 +-138.30114,58.070445,13.719616,915097.819789111,1005259.78802386,186.393508911133,143,2.27043078412761,0.551436533218959 +-138.23995,58.0626655,13.719616,918801.872830353,1005259.80049596,181.193450927734,143,2.25814249644594,0.506801964932658 +-138.17879,58.0548562,13.719616,922505.770882251,1005259.76778957,185.22492980957,143,2.26769943887989,0.541515507675707 +-138.11766,58.0470173,13.719616,926209.51406889,1005259.71026721,179.165054321289,143,2.25325330557486,0.489043028174864 +-138.05655,58.0391486,13.719616,929913.685062821,1005259.74490197,172.170425415039,143,2.235958552564,0.426223548825456 +-137.99547,58.0312503,13.719616,933617.711927507,1005259.75316093,173.643310546875,143,2.23965805716283,0.439661205472142 +-137.93442,58.0233224,13.719616,937321.600002175,1005259.7337186,177.566772460938,143,2.24936170081787,0.474907608922888 +-137.87339,58.0153647,13.719616,941025.932001397,1005259.80527074,180.405120849609,143,2.25624886095073,0.499923740316675 +-137.8124,58.0073775,13.719616,944729.561206047,1005259.71621653,179.344833374023,143,2.25368886989143,0.49062512209508 +-137.75143,57.9993607,13.719616,948433.639631623,1005259.73837044,178.387298583984,143,2.25136392878863,0.482180272405477 +-137.69049,57.9913143,13.719616,952137.600584672,1005259.72875521,177.511032104492,143,2.24922534912755,0.474412340665028 +-137.62957,57.9832383,13.719616,955842.021383616,1005259.83003008,172.686721801758,143,2.2372589451533,0.430946945878807 +-137.56869,57.9751328,13.719616,959545.760578303,1005259.76446978,165.105621337891,143,2.21776185990402,0.360127967231239 +-137.50783,57.9669978,13.719616,963249.967454345,1005259.81923411,168.891784667969,143,2.227608524881,0.395893864945629 +-137.447,57.9588333,13.719616,966954.075264596,1005259.84915191,167.365615844727,143,2.22366623990143,0.381574360659668 +-137.38621,57.9506393,13.719616,970657.517255899,1005259.70683216,165.108978271484,143,2.21777068990571,0.360160040317703 +-137.32543,57.9424158,13.719616,974362.014704761,1005259.82953117,171.020126342773,143,2.23304722293755,0.415648768645994 +-137.26469,57.9341629,13.719616,978065.85404285,1005259.78837972,179.730606079102,143,2.25462203881993,0.494014657996346 +-137.20398,57.9258806,13.719616,981769.612487106,1005259.72833019,334.950439453125,340,2.52498055191945,1.47603394557615 +-137.14329,57.9175689,13.719616,985473.867248438,1005259.79657677,400.327484130859,340,2.60241540723383,1.75729944218612 +-137.08263,57.9092278,13.719616,989178.051513849,1005259.84466004,430.847381591797,340,2.63432345793219,1.87319858978696 +-137.02201,57.9008573,13.719616,992881.598464271,1005259.72190045,440.691802978516,340,2.64413497255597,1.9088368113856 +-136.96141,57.8924575,13.719616,996585.654466778,1005259.73639268,444.392120361328,350,2.64776634974243,1.92202700982507 +-136.90084,57.8840284,13.719616,1000289.6526606,1005259.7380286,464.731140136719,350,2.66720177412818,1.99262201861652 +-136.8403,57.87557,13.719616,1003993.59818781,1005259.72565854,195.803802490234,150,2.29182112150436,0.629132343981443 +-136.77978,57.8670823,13.719616,1007698.0681933,1005259.84987996,153.072311401367,150,2.18489664012277,0.240752108318069 +-136.7193,57.8585653,13.719616,1011401.92378908,1005259.8066494,138.241592407227,150,2.14063872780907,0.0799947383288774 +-136.65885,57.8500191,13.719616,1015105.73922416,1005259.75681913,121.640823364258,150,2.08507935114115,-0.121812775953929 +-136.59843,57.8414437,13.719616,1018809.51958672,1005259.69927395,109.685752868652,150,2.0401502205341,-0.285008202369345 +-136.53803,57.8328391,13.719616,1022513.84196774,1005259.78687661,83.2238235473633,50,1.92024766468182,-0.720528508821508 +-136.47767,57.8242053,13.7179467,1026217.56742528,1005259.71115589,33.5688972473145,50,1.52593707472217,-2.15277711900236 +-136.41733,57.8155424,12.27992495,1029921.84212417,1005259.79030095,14.469352722168,50,1.16044910364991,-3.48033375058973 +-153.54351,59.0088477,13.719616,26137.5071494422,1001555.77067431,18.062141418457,32,1.25676923828574,-3.13047152908886 +-153.47882,59.0086038,12.94542004,29841.6418636252,1001555.77022022,18.5078678131104,32,1.26735638902098,-3.09201597574482 +-153.41413,59.0083277,13.334407,33545.8331337407,1001555.7786572,35.8767585754395,32,1.55481319812925,-2.04789079672165 +-153.34945,59.0080192,13.59824028,37249.5156155561,1001555.76816736,33.388427734375,32,1.52359596854937,-2.1612806848402 +-153.28476,59.0076785,13.719616,40953.8412700729,1001555.77193323,72.959831237793,32,1.86308382076197,-0.928163906123862 +-153.22008,59.0073056,13.719616,44657.6719667993,1001555.77836159,103.258834838867,132,2.01392722020854,-0.380257624341253 +-153.1554,59.0069003,13.719616,48361.5875592182,1001555.77090504,128.267166137695,132,2.10811549978766,-0.0381389088983534 +-153.09072,59.0064628,13.719616,52065.5948086567,1001555.77213716,149.854598999023,132,2.17567007587192,0.207238593435354 +-153.02604,59.005993,13.719616,55769.7008807715,1001555.77111444,153.497604370117,132,2.18610160185257,0.245128873251037 +-152.96136,59.005491,13.719616,59473.9126346675,1001555.77926645,155.100616455078,132,2.19061352394195,0.261517462110455 +-152.89669,59.0049567,13.719616,63177.6646902138,1001555.77617142,158.033645629883,132,2.19874955882668,0.291069863067331 +-152.83202,59.0043901,13.719616,66881.536647045,1001555.77051361,166.466857910156,132,2.22132778223006,0.373080414934957 +-152.76735,59.0037913,13.719616,70585.5353301262,1001555.77377386,166.90412902832,132,2.2224670807897,0.377218672491755 +-152.70268,59.0031602,13.719616,74289.6679570563,1001555.77509592,158.645721435547,132,2.20042836397511,0.297167762545127 +-152.63801,59.0024968,13.719616,77993.9415591298,1001555.77481826,150.615173339844,132,2.17786872595382,0.215224718090037 +-152.57335,59.0018012,13.719616,81697.7903602407,1001555.77217105,150.177124023438,132,2.17660378308741,0.210630084548615 +-152.50869,59.0010734,13.719616,85401.7939244273,1001555.77871296,150.071853637695,132,2.1762992468331,0.209523921949653 +-152.44403,59.0003133,13.719616,89105.9595102816,1001555.78365767,143.101547241211,132,2.1556443294599,0.134499366549815 +-152.37938,58.9995209,13.719616,92809.7215797721,1001555.77343765,120.834007263184,132,2.08218917839313,-0.132310708312143 +-152.31473,58.9986963,13.719616,96513.6594437997,1001555.77251255,102.407234191895,132,2.01033063690005,-0.393321441484745 +-152.25008,58.9978394,13.719616,100217.780391365,1001555.77014859,107.717330932617,132,2.03228558373319,-0.313574808021088 +-152.18544,58.9969504,13.719616,103921.518271307,1001555.7735062,114.237251281738,132,2.05780774478631,-0.220871034326124 +-152.12079,58.996029,13.719616,107626.026125999,1001555.78027574,131.406463623047,132,2.11861672783246,4.54870925364349e-06 +-152.05616,58.9950754,13.719616,111329.592658377,1001555.76468207,120,132,2.07918124604762,-0.143236377140402 +-151.99152,58.9940896,13.719616,115033.942559505,1001555.77585325,174.285278320312,132,2.24126070429718,0.445482477305154 +-151.92689,58.9930716,13.719616,118737.937686218,1001555.78023134,191.943908691406,132,2.28317433440765,0.59772474520747 +-151.86227,58.9920213,13.719616,122441.585387489,1001555.7655145,172.96305847168,132,2.23795335622088,0.433469245080886 +-151.79764,58.9909388,13.719616,126146.037446821,1001555.77975431,125.782096862793,132,2.09961883040167,-0.0690012372991671 +-151.73303,58.9898241,13.719616,129849.583151427,1001555.7665455,116.537895202637,132,2.06646717000833,-0.189417530273699 +-151.66841,58.9886772,13.719616,133553.94718744,1001555.78346815,102.402160644531,132,2.01030912017592,-0.393399596368269 +-151.6038,58.987498,13.719616,137257.991809863,1001555.78030127,81.6135711669922,132,1.91176238170578,-0.751349478531376 +-151.5392,58.9862867,13.719616,140961.72320701,1001555.7783454,88.5532073974609,132,1.94720429595853,-0.622614329835924 +-151.4746,58.9850431,13.719616,144665.721745746,1001555.77601556,107.212326049805,132,2.03024471845079,-0.320987813247704 +-151.41,58.9837673,13.719616,148369.994004464,1001555.7851479,121.704627990723,132,2.08530709320638,-0.120985551768938 +-151.34541,58.9824593,13.719616,152073.974396952,1001555.78352531,126.604751586914,132,2.10245000543846,-0.0587176014677182 +-151.28083,58.9811191,13.719616,155777.669902429,1001555.77017348,117.638359069824,132,2.07054895793049,-0.174591311482182 +-151.21625,58.9797467,13.719616,159481.660065516,1001555.76814956,144.786712646484,132,2.16072870765468,0.152967279379288 +-151.15167,58.9783421,13.719616,163185.951862879,1001555.7781867,152.717788696289,132,2.18388962698886,0.237094349185547 +-151.0871,58.9769054,13.719616,166889.979213042,1001555.78707329,168.890075683594,132,2.22760413031415,0.395877902624481 +-151.02254,58.9754364,13.719616,170593.750059461,1001555.77156702,174.767791748047,132,2.24246139880788,0.44984374248035 +-150.95798,58.9739353,13.719616,174297.842950227,1001555.77935988,153.63720703125,131,2.18649640353127,0.246562905635695 +-150.89343,58.972402,13.719616,178001.692780044,1001555.77328235,145.494369506836,131,2.16284618686539,0.160658568261315 +-150.82888,58.9708365,13.719616,181705.879085324,1001555.77984059,151.138092041016,131,2.17937393540664,0.220692068452246 +-150.76434,58.9692389,13.719616,185409.835723261,1001555.78311715,149.473419189453,131,2.17456396907712,0.203220897842334 +-150.69981,58.967609,13.719616,189113.570738635,1001555.75996016,150.780746459961,131,2.17834588901362,0.216957910519142 +-150.63528,58.9659471,13.719616,192817.661997523,1001555.77209479,116.373687744141,131,2.06585479681482,-0.191641844501258 +-150.57076,58.964253,13.719616,196521.544985802,1001555.76848524,115.273277282715,131,2.06172864056656,-0.206629221717185 +-150.50624,58.9625267,13.719616,200225.799232219,1001555.77851155,119.451766967773,131,2.07719257835277,-0.150459785830386 +-150.44173,58.9607683,13.719616,203929.858531918,1001555.78354997,115.132423400879,131,2.06119764614172,-0.208557945029081 +-150.37723,58.9589777,13.719616,207633.730420679,1001555.77170137,122.072296142578,131,2.08661711359624,-0.116227183795945 +-150.31273,58.957155,13.719616,211337.993801945,1001555.78523145,142.410934448242,131,2.15354333612824,0.126867959086029 +-150.24825,58.9553002,13.719616,215041.510465285,1001555.76034938,169.770782470703,131,2.22986295031562,0.404082581601252 +-150.18376,58.9534133,13.719616,218746.005031841,1001555.79351011,189.431640625,131,2.27745252060798,0.576941484318809 +-150.11929,58.9514942,13.719616,222449.767373859,1001555.77574356,211.368835449219,230,2.32504095463571,0.749796259798884 +-150.05482,58.949543,13.719616,226153.948911071,1001555.78399215,217.981369018555,230,2.33841937581465,0.798390504102392 +-149.99036,58.9475597,13.719616,229857.98399257,1001555.7846822,229.314804077148,230,2.36043209276517,0.878346975121622 +-149.92591,58.9455443,13.719616,233561.879532259,1001555.77719512,228.582015991211,230,2.35904205867949,0.873297974567186 +-149.86147,58.9434968,13.719616,237265.642442147,1001555.76092918,236.599700927734,230,2.37401419132523,0.927681033808645 +-149.79703,58.9414173,13.719616,240969.851492006,1001555.78274025,230.167877197266,230,2.36204471230235,0.884204469568078 +-149.7326,58.9393056,13.719616,244673.942426467,1001555.78457831,232.312606811523,230,2.36607277811758,0.898835554333468 +-149.66818,58.9371619,13.719616,248377.920726912,1001555.78820373,235.534301757812,230,2.37205416403106,0.920561655228724 +-149.60377,58.934986,13.719616,252081.79474394,1001555.77077211,238.684799194336,230,2.37782476154454,0.941522112490204 +-149.53937,58.9327782,13.719616,255785.569161347,1001555.76522795,240.2822265625,230,2.38072164766073,0.952044429717824 +-149.47497,58.9305382,13.719616,259489.825664186,1001555.77668187,240.20817565918,230,2.38058778484558,0.951558201764954 +-149.41058,58.9282662,13.719616,263193.997072436,1001555.78899804,241.523849487305,230,2.38296002199985,0.960174844213157 +-149.34621,58.9259622,13.719616,266897.51768285,1001555.76151829,240.039093017578,230,2.38028197712503,0.950447420837702 +-149.28184,58.9236261,13.719616,270601.540283514,1001555.76245963,225.914672851562,230,2.35394443867391,0.854781963701313 +-149.21747,58.9212579,13.719616,274306.071765932,1001555.79306175,212.080352783203,230,2.32650043714899,0.755097516864894 +-149.15312,58.9188578,13.719616,278009.972255866,1001555.79315434,215.785766601562,230,2.33402279488691,0.782420867263705 +-149.08878,58.9164256,13.719616,281713.822794032,1001555.78078348,234.811859130859,230,2.37072002709445,0.915715689074368 +-149.02445,58.9139614,13.719616,285417.62942851,1001555.7667128,261.093627929688,230,2.41679627286184,1.08307776517142 +-148.96012,58.9114652,13.719616,289121.971576051,1001555.79410842,282.071472167969,230,2.45035916518221,1.20498776988221 +-148.89581,58.9089369,13.719616,292825.711809392,1001555.76495995,287.655151367188,230,2.45887215583522,1.2359093817834 +-148.8315,58.9063767,13.719616,296530.000401485,1001555.78885122,282.490173339844,230,2.45100334511649,1.20732761527078 +-148.76721,58.9037845,13.719616,300233.699909543,1001555.7655733,291.427154541016,230,2.4645300159236,1.25646034453844 +-148.70292,58.9011603,13.719616,303937.962307519,1001555.78468276,278.304565429688,230,2.44452033074891,1.1837794566512 +-148.63865,58.8985042,13.719616,307641.648398841,1001555.76606096,268.690032958984,230,2.42925155660363,1.12831891081349 +-148.57438,58.8958161,13.719616,311345.911032434,1001555.79038496,269.094940185547,230,2.42990553176541,1.13069433526417 +-148.51013,58.893096,13.719616,315049.611908202,1001555.76419649,266.5859375,230,2.42583723649859,1.11591712564801 +-148.44588,58.8903439,13.719616,318753.902990173,1001555.78158032,271.839935302734,230,2.43431325816392,1.14670445563393 +-148.38165,58.8875599,13.719616,322457.645028629,1001555.75801853,280.380065917969,230,2.44774713351155,1.19550012530633 +-148.31742,58.884744,13.719616,326161.989950147,1001555.78985714,285.822631835938,330,2.45609661386125,1.22582782111538 +-148.25321,58.8818962,13.719616,329865.799412058,1001555.77923926,305.471527099609,330,2.48497073601948,1.33070687428904 +-148.18901,58.8790164,13.719616,333569.65374589,1001555.76341139,354.85693359375,330,2.55005329538169,1.56710530630448 +-148.12482,58.8761047,13.719616,337273.558781691,1001555.75335423,459.241851806641,430,2.66204145948671,1.97387828293826 +-148.06064,58.8731611,13.719616,340977.521302135,1001555.74892769,646.316040039062,430,2.8104449342207,2.51292206174095 +-138.68325,58.0842212,10.80288205,892873.935097352,1001555.80381263,606.089721679688,440,2.78253691912691,2.41155218517977 +-138.62196,58.0766274,13.54138108,896577.513247344,1001555.7128973,547.490295410156,341,2.73837642545339,2.25114866749776 +-138.56068,58.0690037,13.719616,900282.047738266,1001555.83889327,280.293243408203,341,2.44761262902714,1.19501156662753 +-138.49944,58.0613502,13.719616,903985.823767101,1001555.78624178,229.935638427734,241,2.36160628911612,0.882611991417271 +-138.43822,58.0536669,13.719616,907689.991912193,1001555.82521434,238.404296875,241,2.37731407863651,0.939667166404816 +-138.37703,58.0459538,13.719616,911393.985046094,1001555.81885028,271.761444091797,241,2.43418784163145,1.14624890699056 +-138.31587,58.038211,13.719616,915097.805988254,1001555.77662415,240.921661376953,241,2.38187584936968,0.956236819766708 +-138.25473,58.0304385,13.719616,918802.032702876,1001555.835504,266.6357421875,241,2.42591836561183,1.11621180974386 +-138.19363,58.0226362,13.719616,922505.528082208,1001555.70711842,238.80339050293,241,2.37804048856395,0.942305694599316 +-138.13254,58.0148043,13.719616,926210.009954319,1001555.82854874,222.108200073242,241,2.34656459268094,0.827976256637091 +-138.07149,58.0069427,13.719616,929913.768623071,1001555.77086245,342.934326171875,241,2.53521095820013,1.51319370123624 +-138.01046,57.9990514,13.719616,933617.954595843,1001555.81221312,227.505218505859,241,2.35699136293733,0.865849262304837 +-137.94946,57.9911305,13.719616,937321.998000424,1001555.82265584,179.556884765625,143,2.25420206197335,0.49248918221622 +-137.88849,57.98318,13.719616,941025.904169195,1001555.80086929,191.167587280273,143,2.28141425897245,0.591331648851245 +-137.82755,57.9751999,13.719616,944729.678428617,1001555.7455435,195.840911865234,143,2.2919034226117,0.629431285094377 +-137.76663,57.9671902,13.719616,948433.89866589,1001555.79819242,195.430206298828,143,2.290991690473,0.626119613732387 +-137.70574,57.959151,13.719616,952137.994915516,1001555.82666783,191.811386108398,143,2.28287438373807,0.596635238761098 +-137.64488,57.9510822,13.719616,955841.975179693,1001555.81885215,184.527160644531,143,2.26606029922079,0.535561684576806 +-137.58405,57.9429839,13.719616,959545.842027838,1001555.78431163,179.029144287109,143,2.25292373585574,0.487845936886472 +-137.52325,57.9348561,13.719616,963249.600726886,1001555.72178479,187.895858764648,143,2.27391720833107,0.564100221050469 +-137.46247,57.9266989,13.719616,966953.82635145,1001555.78644861,173.874649047852,143,2.24023626641212,0.441761426502925 +-137.40172,57.9185122,13.719616,970657.954323056,1001555.82174676,168.323959350586,143,2.22614593815739,0.390581332501652 +-137.341,57.910296,13.719616,974361.989890669,1001555.826451,169.568725585938,143,2.22934575618778,0.402203984907044 +-137.28031,57.9020504,13.719616,978065.935514566,1001555.81016228,188.480361938477,143,2.27526610708267,0.56899980633031 +-137.21965,57.8937754,13.719616,981769.796402023,1001555.77166653,349.154479980469,340,2.54301761881958,1.54154972084886 +-137.15902,57.8854711,13.719616,985473.574951929,1001555.72057354,395.514556884766,340,2.59716247230496,1.73821928318758 +-137.09841,57.8771374,13.719616,989177.85170881,1001555.79382052,426.871459960938,340,2.63029711944246,1.85857377916085 +-137.03783,57.8687743,13.719616,992882.059295144,1001555.84239378,439.855285644531,340,2.64330981515973,1.9058396041991 +-136.97729,57.860382,13.719616,996585.62466361,1001555.73666943,438.719573974609,350,2.64218701138129,1.90176126039569 +-136.91677,57.8519603,13.719616,1000289.70374893,1001555.75343573,456.358551025391,350,2.65930619254196,1.96394301267202 +-136.85628,57.8435093,13.719616,1003993.72630382,1001555.75283776,244.394317626953,250,2.38809110397662,0.978812398509394 +-136.79582,57.8350291,13.719616,1007697.69460228,1001555.74452607,166.821533203125,150,2.22225210833835,0.37643783118923 +-136.73539,57.8265197,13.719616,1011401.61374412,1001555.72735687,143.557769775391,150,2.15702670278349,0.139520541029719 +-136.67498,57.8179811,13.719616,1015106.0613897,1001555.85304885,126.885192871094,150,2.10341094416262,-0.055227197742364 +-136.61461,57.8094132,13.719616,1018809.90038405,1001555.80454426,121.015022277832,150,2.08283928508848,-0.129949335235738 +-136.55427,57.8008162,13.719616,1022513.70260369,1001555.7546057,112.718795776367,150,2.05199634037035,-0.241979713904839 +-136.49395,57.79219,13.719616,1026218.04857155,1001555.845865,77.0530014038086,50,1.88678956022153,-0.842057894115055 +-136.43367,57.7835347,13.719616,1029921.79530352,1001555.77951912,60.2055587768555,50,1.77963659150138,-1.23126806100886 +-136.37342,57.7748502,13.69988749,1033625.5233298,1001555.69766848,43.8263168334961,50,1.64173497405115,-1.73216609662843 +-136.31319,57.7661367,8.742702657,1037329.80439486,1001555.77699154,48.5908737182617,50,1.68655470823379,-1.56936802925132 +-136.25299,57.7573941,6.249714874,1041034.07387354,1001555.85055637,48.443920135498,50,1.68523927948194,-1.57414604193877 +-153.4147,58.9751949,10.0226829,33545.839591537,997851.776722128,26.5450420379639,32,1.42398341744667,-2.52310190269795 +-153.35008,58.9748868,13.719616,37249.6900409249,997851.779681757,38.8586273193359,32,1.58948745508602,-1.92194399843641 +-153.28546,58.9745464,13.719616,40953.6110933251,997851.776434183,53.8048706054688,32,1.73082159130458,-1.40857807491187 +-153.22084,58.9741738,13.719616,44657.6096494585,997851.778339746,119.637741088867,132,2.07786820441025,-0.148005719146729 +-153.15622,58.9737689,13.719616,48361.6928502564,997851.774419884,141.653747558594,132,2.15122806860223,0.118458246588416 +-153.0916,58.9733318,13.719616,52065.8675739696,997851.776069208,156.990325927734,132,2.19587289109937,0.28062098479902 +-153.02699,58.9728625,13.719616,55769.5676943284,997851.775123806,158.488372802734,132,2.19999740653588,0.29560240211834 +-152.96237,58.9723609,13.719616,59473.9466324774,997851.77689488,161.384658813477,132,2.20786224842003,0.324169752690966 +-152.89776,58.9718271,13.719616,63177.8649839448,997851.775475242,167.583786010742,132,2.22423199766718,0.383629354348206 +-152.83315,58.9712611,13.719616,66881.9028698695,997851.779547986,175.758346557617,132,2.24491595831687,0.458759403218007 +-152.76854,58.9706628,13.719616,70586.0674937351,997851.778238982,174.081878662109,132,2.24075356487577,0.443640402174564 +-152.70394,58.9700323,13.719616,74289.7925412754,997851.771858863,166.995590209961,132,2.22270500304719,0.378082874040733 +-152.63934,58.9693696,13.719616,77993.6581319549,997851.770815638,157.078674316406,132,2.19611722733546,0.281508483749031 +-152.57474,58.9686747,13.719616,81697.6712602305,997851.775463557,155.378860473633,132,2.19139193207009,0.264344862611658 +-152.51014,58.9679475,13.719616,85401.8391706655,997851.774998231,138.655151367188,132,2.14193600928196,0.0847068349194253 +-152.44555,58.9671881,13.719616,89105.5955029711,997851.767567395,143.264770507812,132,2.15613940843592,0.13629763470035 +-152.38096,58.9663965,13.719616,92809.5203739631,997851.765878782,86.8767776489258,132,1.93890370410431,-0.652764448675233 +-152.31637,58.9655727,12.21690556,96513.6207753193,997851.770355444,25.124439239502,132,1.40009637737749,-2.60986645026924 +-152.25178,58.9647167,13.71900476,100217.90369795,997851.781437666,57.50390625,132,1.75969734738873,-1.30369308685289 +-152.1872,58.9638284,13.6189469,103921.803312666,997851.772760124,87.278564453125,132,1.94090759441789,-0.645485747089048 +-152.12262,58.962908,13.1638645,107625.899133803,997851.781679517,70.9911193847656,132,1.85120402416393,-0.971314718199464 +-152.05805,58.9619553,13.719616,111329.625646447,997851.769575226,69.9911422729492,132,1.84504308136583,-0.993693020950328 +-151.99348,58.9609704,13.70154982,115033.562657414,997851.763778994,88.3250732421875,132,1.94608400623895,-0.626683541859948 +-151.92891,58.9599534,13.719616,118737.716804743,997851.775990137,167.649154663086,132,2.22440136792838,0.384244555479965 +-151.86435,58.9589041,13.719616,122441.522635933,997851.765968276,164.8955078125,132,2.21720882448129,0.358119184723842 +-151.79979,58.9578226,13.719616,126145.559922345,997851.762768856,156.39958190918,132,2.19423558775977,0.274673831736706 +-151.73523,58.956709,13.719616,129849.835266484,997851.778141583,128.890075683594,132,2.11021947870498,-0.0304966569352853 +-151.67068,58.9555631,13.719616,133553.78327797,997851.770226425,107.700531005859,132,2.03221784454539,-0.313820856085849 +-151.60613,58.9543851,13.719616,137257.983289586,997851.780973752,102.384078979492,132,2.01023242784166,-0.393678164816472 +-151.54159,58.9531749,13.719616,140961.869538493,997851.778614757,86.7695159912109,132,1.93836717492176,-0.65471327580694 +-151.47705,58.9519325,13.719616,144666.022128375,997851.783905713,89.7070617675781,132,1.9528266321854,-0.602192399885386 +-151.41252,58.9506579,13.719616,148369.874912941,997851.775168672,94.6463165283203,132,1.97610371663523,-0.517643385222256 +-151.34799,58.9493512,13.719616,152074.007547233,997851.78547928,114.781356811523,132,2.05987135416486,-0.213375416050476 +-151.28347,58.9480123,13.719616,155777.854307115,997851.780907758,146.325546264648,132,2.16532015410369,0.16964472341139 +-151.21895,58.9466412,13.719616,159481.995291411,997851.784509765,171.116622924805,132,2.23329220062147,0.416538597517589 +-151.15444,58.945238,13.719616,163185.863870042,997851.783613023,164.030563354492,132,2.21492477645941,0.349822870376178 +-151.08993,58.9438026,13.719616,166890.040596356,997851.791253582,154.073974609375,132,2.18772928610272,0.251041087034906 +-151.02543,58.942335,13.719616,170593.959316436,997851.78250957,164.14973449707,132,2.21524018461912,0.350968522838684 +-150.96094,58.9408353,13.719616,174297.626488005,997851.767657353,147.492431640625,131,2.16876973569694,0.182174588366668 +-150.89645,58.9393035,13.719616,178001.622170617,997851.772625038,149.488952636719,131,2.17460909910734,0.203384822993507 +-150.83196,58.9377395,13.719616,181705.953831036,997851.787062161,139.595031738281,131,2.14486996178968,0.0953637878608895 +-150.76748,58.9361433,13.719616,185410.055309648,997851.78388408,157.703353881836,131,2.19784092958056,0.28776946229681 +-150.70301,58.9345151,13.719616,189113.932460266,997851.784597853,142.834762573242,131,2.15483391721914,0.131555717976685 +-150.63855,58.9328547,13.719616,192817.593310739,997851.766066619,120.722389221191,131,2.08178782199046,-0.133768549325182 +-150.57409,58.9311622,13.719616,196521.617369251,997851.768257366,120.353981018066,131,2.08046046025778,-0.138589906005039 +-150.50963,58.9294376,13.719616,200226.011561897,997851.792070269,124.917678833008,131,2.09662390575843,-0.0798796584399992 +-150.44519,58.9276808,13.719616,203929.637162419,997851.765845649,126.26106262207,131,2.10126944005992,-0.0630057518894991 +-150.38075,58.925892,13.719616,207633.646157147,997851.772026452,128.799865722656,131,2.10991541026029,-0.0316011203161863 +-150.31631,58.924071,13.719616,211338.046674199,997851.789239468,141.062393188477,131,2.14941124757701,0.111859034052489 +-150.25189,58.922218,13.719616,215041.698155605,997851.776014773,158.575576782227,131,2.20023629971877,0.296470130345508 +-150.18747,58.9203328,13.719616,218745.755018159,997851.773545316,174.783279418945,131,2.24249988365641,0.449983530434869 +-150.12306,58.9184156,13.719616,222449.649781484,997851.771657466,191.444519042969,131,2.2820429372365,0.593615187748927 +-150.05865,58.9164662,13.719616,226153.963777713,997851.781430997,203.397750854492,230,2.30834614624217,0.689155950540811 +-149.99426,58.9144848,13.719616,229857.556355159,997851.756996636,227.096130371094,230,2.35620973407531,0.86301016317889 +-149.92987,58.9124714,13.719616,233561.580640645,997851.766396543,235.991516113281,230,2.37289639037936,0.923620861721104 +-149.86548,58.9104258,13.719616,237266.044901262,997851.788384593,239.064270019531,230,2.37851467233957,0.944028065417901 +-149.80111,58.9083482,13.719616,240969.80841477,997851.773791615,238.379974365234,230,2.3772697687361,0.939506220199244 +-149.73674,58.9062386,13.719616,244674.024302266,997851.79405666,237.519241333008,230,2.3756987973978,0.933800003898646 +-149.67239,58.9040969,13.719616,248377.553913201,997851.764342586,237.83137512207,230,2.37626914693347,0.935871676206175 +-149.60804,58.9019231,13.719616,252081.550397139,997851.758355072,237.932510375977,230,2.37645378677141,0.936542340799044 +-149.54369,58.8997173,13.719616,255786.019903296,997851.78840051,239.623779296875,230,2.37952991348766,0.94771571104642 +-149.47936,58.8974795,13.719616,259489.823047133,997851.777500176,236.493850708008,230,2.3738198527343,0.926975140576613 +-149.41504,58.8952097,13.719616,263193.539815235,997851.763123273,234.839263916016,230,2.37077071044812,0.915899785481354 +-149.35072,58.8929078,13.719616,266897.750973985,997851.773835792,231.661987304688,230,2.36485477760451,0.894411428818016 +-149.28641,58.8905739,13.719616,270601.889496586,997851.781261623,228.491546630859,230,2.35887013736218,0.872673507271513 +-149.22211,58.888208,13.719616,274305.96223879,997851.784962285,213.076904296875,230,2.32853637848002,0.76249263689472 +-149.15782,58.8858101,13.719616,278009.976054148,997851.784515935,218.334884643555,230,2.33912313102666,0.800946743904153 +-149.09354,58.8833803,13.719616,281713.93696889,997851.790665095,237.65510559082,230,2.37594714876376,0.934702086946349 +-149.02927,58.8809184,13.719616,285417.853471476,997851.780725145,260.455535888672,230,2.41573359263972,1.07921780728552 +-148.96501,58.8784246,13.719616,289121.730747718,997851.776618699,281.709320068359,230,2.4498012154178,1.20296113708316 +-148.90076,58.8758987,13.719616,292825.577324615,997851.755697719,287.505065917969,230,2.45864550148073,1.23508610847429 +-148.83651,58.8733409,13.719616,296529.971464575,997851.784565372,286.539581298828,230,2.45718462194858,1.22977977703699 +-148.77228,58.8707512,13.719616,300233.773726199,997851.774153513,286.406097412109,230,2.45698225960036,1.22904473922828 +-148.70806,58.8681295,13.719616,303937.564928673,997851.757104451,284.757965087891,230,2.45447588075935,1.219940855886 +-148.64384,58.8654759,13.719616,307641.924130753,997851.790594885,291.415679931641,230,2.46451291574071,1.25639823179329 +-148.57964,58.8627903,13.719616,311345.712795094,997851.771118992,297.219024658203,230,2.47307660468356,1.28750399435392 +-148.51545,58.8600728,13.719616,315049.509953964,997851.755327067,282.548553466797,230,2.45109308822922,1.20765358787146 +-148.45126,58.8573233,13.719616,318753.896459747,997851.779835195,278.124694824219,230,2.44423955179025,1.18275958733103 +-148.38709,58.854542,13.719616,322457.73100131,997851.771260319,284.199859619141,230,2.45362385907123,1.21684606992353 +-148.32293,58.8517287,13.719616,326161.595369541,997851.754555717,281.402038574219,330,2.44932723929037,1.20123952050206 +-148.25877,58.8488836,13.719616,329866.067578296,997851.801474289,310.335113525391,330,2.4918309175357,1.35562501164669 +-148.19463,58.8460065,13.719616,333570.010083084,997851.790783649,391.599029541016,330,2.59284160686577,1.72252466661464 +-148.1305,58.8430976,13.719616,337274.000849451,997851.79370801,473.487030029297,430,2.67530808711151,2.02206646114408 +-137.96448,57.9589361,11.86264281,937321.956874566,997851.819414561,580.50048828125,440,2.76380258937651,2.34350375221622 +-137.90356,57.9509926,13.719616,941026.009658869,997851.824274824,468.785461425781,440,2.67097413432303,2.00632430758304 +-137.84267,57.9430196,13.719616,944729.924064399,997851.80321395,355.781036376953,341,2.55118279586614,1.57120797445553 +-137.78181,57.9350171,13.719616,948433.705381003,997851.754918452,364.071563720703,341,2.56118675912766,1.60754522443677 +-137.72097,57.926985,13.719616,952137.93472788,997851.810619774,333.924591064453,241,2.52364840279305,1.47119519971583 +-137.66016,57.9189234,13.719616,955842.041567615,997851.837613673,373.725860595703,341,2.57255315063376,1.64883120267804 +-137.59938,57.9108323,13.719616,959546.031172271,997851.834620245,377.081268310547,341,2.57643495915868,1.66293103921903 +-137.53863,57.9027117,13.719616,963249.908807957,997851.800370727,539.786865234375,341,2.73222231255537,2.22879517289344 +-137.47791,57.8945617,13.719616,966953.676984383,997851.744433822,544.907653808594,241,2.73632290807569,2.24368970624971 +-137.41721,57.8863823,13.719616,970657.914050457,997851.811714227,240.233810424805,241,2.3806341298262,0.95172653996273 +-137.35654,57.8781734,13.719616,974362.054870487,997851.845103815,182.170532226562,143,2.26047812715721,0.515285642331338 +-137.29591,57.8699351,13.719616,978065.528782187,997851.70692201,193.632095336914,143,2.2869773450821,0.611538365464376 +-137.23529,57.8616675,13.719616,981770.057575398,997851.848586979,295.826416015625,240,2.47103695200567,1.28009539365296 +-137.17471,57.8533705,13.719616,985473.929847617,997851.816243321,394.591033935547,340,2.59614721280529,1.73453157090084 +-137.11416,57.8450441,13.719616,989177.723917724,997851.755965927,420.536712646484,340,2.62380391548187,1.83498860903105 +-137.05363,57.8366885,13.719616,992882.012459753,997851.837687552,424.643524169922,340,2.62802450546373,1.85031899652148 +-136.99314,57.8283035,13.719616,996585.660006746,997851.740150212,430.095855712891,350,2.63356525783032,1.87044459060511 +-136.93267,57.8198893,13.719616,1000289.81230573,997851.783360852,435.919586181641,350,2.6394063826206,1.89166122306641 +-136.87223,57.8114458,13.719616,1003993.90419247,997851.805841382,349.929534912109,350,2.54398059955072,1.54504754172643 +-136.81182,57.8029731,13.719616,1007697.93794301,997851.817235333,183.014419555664,150,2.2624853087837,0.522576298905426 +-136.75144,57.7944711,13.719616,1011401.921525,997851.805596733,173.839218139648,150,2.24014776003129,0.441439946065513 +-136.69109,57.78594,13.719616,1015105.85430447,997851.791376993,139.965713500977,150,2.14602166238547,0.099547093152852 +-136.63077,57.7773797,13.719616,1018809.7442271,997851.762648586,138.782257080078,150,2.14233394634386,0.0861522559107805 +-136.57048,57.7687902,13.719616,1022513.59637382,997851.718291853,123.582138061523,150,2.09195570455625,-0.0968358976435998 +-136.51021,57.7601716,13.719616,1026217.98603626,997851.822506692,115.294342041016,150,2.06180799523349,-0.20634098291682 +-136.44998,57.7515239,13.719616,1029921.77200502,997851.765693649,87.5431823730469,50,1.94222233005334,-0.640710251998198 +-136.38978,57.7428471,13.719616,1033625.53243774,997851.700723658,54.7430534362793,50,1.73832901765473,-1.38130895957531 +-136.3296,57.7341413,13.24763783,1037329.84254917,997851.793484574,40.2551498413086,50,1.604821447551,-1.86624656104642 +-136.26946,57.7254063,7.650213167,1041033.56697532,997851.709507439,21.006721496582,50,1.32235827767744,-2.89223341704255 +-136.20934,57.7166424,10.47259791,1044737.84814025,997851.792999975,39.1697463989258,50,1.59295075975558,-1.90936428735098 +-153.35071,58.9417537,13.03449012,37249.7942908325,994147.781030242,20.1000003814697,32,1.30319606566279,-2.9618360405196 +-153.28615,58.9414136,13.719616,40953.8766254241,994147.77687409,34.5689353942871,32,1.53868600495444,-2.10646936549177 +-153.22159,58.9410413,13.719616,44658.0363587157,994147.774747006,141.710357666016,132,2.15140159416279,0.119088540953484 +-153.15704,58.9406369,13.719616,48361.7066619915,994147.778743259,158.897720336914,132,2.20111766654532,0.299671506226689 +-153.09248,58.9402002,13.719616,52066.0421673726,994147.780730224,162.458343505859,132,2.21074202067026,0.334629907472605 +-153.02793,58.9397313,13.719616,55769.9023741054,994147.776996732,162.158218383789,132,2.2099389641609,0.331712977015488 +-152.96338,58.9392302,13.719616,59473.8679584329,994147.77507544,165.23063659668,132,2.21809057610355,0.361321958292881 +-152.89883,58.9386969,13.719616,63177.9459140003,994147.775233972,170.888122558594,132,2.2327118784813,0.414430701864049 +-152.83429,58.9381314,13.719616,66881.5695518232,994147.767686251,175.283248901367,132,2.24374041434076,0.454489491963126 +-152.76974,58.9375337,13.719616,70585.8932288038,994147.772318308,177.169021606445,132,2.24838778684269,0.471370075382305 +-152.7052,58.9369039,13.719616,74289.7763548121,994147.779926162,158.964553833008,132,2.20130029544687,0.300334866524588 +-152.64066,58.9362418,13.719616,77993.8000284724,994147.778564127,164.833145141602,132,2.21704454537525,0.357522476120794 +-152.57612,58.9355475,13.719616,81697.9710335923,994147.779762306,162.780456542969,132,2.211602262193,0.337754550220578 +-152.51159,58.934821,13.719616,85401.7226782607,994147.771031791,147.656265258789,132,2.16925187940534,0.183925871933106 +-152.44706,58.9340624,13.719616,89105.6353727961,994147.775679984,143.951614379883,132,2.15821653974097,0.14384236847259 +-152.38253,58.9332715,13.719616,92809.7166179206,994147.77176081,68.9819717407227,132,1.83873560383069,-1.01660357969127 +-152.12445,58.9297863,12.397086,107625.568358444,994147.770740174,73.6655578613281,132,1.86726448206503,-0.912978550991614 +-151.99543,58.9278506,9.905595497,115033.537850073,994147.76750491,39.9536170959473,132,1.60155610314188,-1.87810722396241 +-151.93092,58.9268345,13.719616,118737.844680832,994147.77674883,134.891159057617,132,2.12998348637825,0.0412918601434486 +-151.86642,58.9257862,13.719616,122441.801967731,994147.771789307,165.225875854492,132,2.21807806272292,0.361276506122738 +-151.80192,58.9247058,13.719616,126145.990004098,994147.781679338,154.142517089844,132,2.18792244657489,0.25174270100333 +-151.73743,58.9235932,13.719616,129849.842436103,994147.776269818,102.568946838379,132,2.01101589627253,-0.390832383851399 +-151.67294,58.9224485,13.719616,133553.939533316,994147.785762701,128.379531860352,132,2.10849578768385,-0.0367575947144214 +-151.60846,58.9212715,13.719616,137257.715363958,994147.767757139,128.770095825195,132,2.10981501887789,-0.0319657704716004 +-151.54398,58.9200625,13.719616,140961.749379656,994147.775946634,136.257766723633,132,2.13436126653827,0.0571932072275238 +-151.4795,58.9188213,13.719616,144666.049339378,994147.788632803,139.147537231445,132,2.14347552417162,0.0902987924199517 +-151.41503,58.9175479,13.719616,148370.048535562,994147.784136294,111.807693481445,132,2.04847168835882,-0.254782256046581 +-151.35057,58.9162424,13.719616,152073.753495753,994147.772632184,142.04524230957,132,2.15242669196037,0.122811988746368 +-151.28611,58.9149048,13.719616,155777.744841715,994147.776598489,156.272750854492,132,2.19388325706444,0.273394066086093 +-151.22165,58.913535,13.719616,159482.029979342,994147.785578265,164.363128662109,132,2.21580439949028,0.353017912293711 +-151.1572,58.9121331,13.719616,163186.041717763,994147.786897494,176.280899047852,132,2.246205256783,0.463442503249422 +-151.09276,58.9106991,13.719616,166889.786992754,994147.779628605,164.412796020508,132,2.21593561505826,0.353494524689257 +-151.02832,58.9092329,13.719616,170593.846920931,994147.777381435,164.1953125,132,2.21536075458341,0.35140646736308 +-150.96389,58.9077346,13.719616,174297.654274871,994147.765858403,141.093978881836,131,2.14950848084018,0.11221221301746 +-150.89946,58.9062042,13.719616,178001.789668378,994147.77098593,136.609878540039,131,2.13548210520428,0.0612644131816788 +-150.83504,58.9046417,13.719616,181705.686349556,994147.766216794,141.369491577148,131,2.1503556960997,0.115289540659332 +-150.77062,58.9030471,13.719616,185409.924929315,994147.778626815,149.2392578125,131,2.17388308056755,0.200747716430659 +-150.70621,58.9014204,13.719616,189113.938652809,994147.78058722,130.223510742188,131,2.11468939946892,-0.0142606288782274 +-150.64181,58.8997616,13.719616,192817.734445796,994147.771289187,120.464027404785,131,2.08085737859578,-0.137148185309645 +-150.57741,58.8980707,13.719616,196521.89291463,994147.779532594,125.657409667969,131,2.09918810282141,-0.0705657628125634 +-150.51302,58.8963477,13.719616,200225.847299801,994147.776066216,129.880584716797,131,2.11354423513341,-0.0184201926072504 +-150.44864,58.8945927,13.719616,203929.603924854,994147.77129427,145.706268310547,131,2.16347823560063,0.162954349672368 +-150.38426,58.8928055,13.719616,207633.744575434,994147.773415508,148.25212097168,131,2.17100091532269,0.190278869609474 +-150.31989,58.8909863,13.719616,211337.701281343,994147.773880099,153.218017578125,131,2.18530983889094,0.242252964182739 +-150.25552,58.889135,13.719616,215042.055238196,994147.793198875,154.862716674805,131,2.18994687359294,0.259095997761887 +-150.19117,58.8872516,13.719616,218745.665995999,994147.766478211,162.579391479492,131,2.21106549369364,0.335804853821925 +-150.12682,58.8853362,13.719616,222449.68717998,994147.769522255,176.620651245117,131,2.24704148178655,0.466479911144714 +-150.06248,58.8833887,13.719616,226153.552648663,994147.758133397,192.118041992188,131,2.28356815179411,0.599155202361737 +-149.99814,58.8814092,13.719616,229857.84231991,994147.777440897,221.007064819336,131,2.34440615677567,0.820136201350201 +-149.93381,58.8793977,13.719616,233561.989386219,994147.793323793,239.286285400391,230,2.37891780790881,0.945492368871736 +-149.86949,58.8773541,13.719616,237266.001415136,994147.794017259,242.241256713867,230,2.38424811088505,0.964853550701355 +-149.80518,58.8752784,13.719616,240969.885309931,994147.77893182,240.91764831543,230,2.38186861521323,0.956210543245645 +-149.74088,58.8731708,13.719616,244673.646539156,994147.769804981,241.21809387207,230,2.38240988130423,0.958176576180858 +-149.67658,58.8710311,13.719616,248377.867073885,994147.781167916,240.2890625,230,2.38073400299698,0.952089307825661 +-149.61229,58.8688594,13.719616,252081.979391366,994147.787350544,233.849334716797,230,2.36893613871219,0.90923609729758 +-149.54801,58.8666557,13.719616,255785.990354548,994147.787828313,232.849334716797,230,2.36707500143028,0.902475915468214 +-149.48374,58.86442,13.719616,259489.906824335,994147.782093375,229.459426879883,230,2.36070590451408,0.879341537547298 +-149.41948,58.8621523,13.719616,263193.735659554,994147.769654594,222.989364624023,230,2.348284150065,0.834222179866534 +-149.35522,58.8598526,13.719616,266898.057399057,994147.790226257,222.34440612793,230,2.34702620768497,0.829652974089759 +-149.29098,58.857521,13.719616,270601.730741217,994147.774680664,219.113662719727,230,2.34066945861404,0.806563447067351 +-149.22674,58.8551573,13.719616,274305.911475801,994147.781211447,216.539001464844,230,2.33553612976786,0.787917731500073 +-149.16251,58.8527617,13.719616,278010.031176247,994147.791504306,219.792861938477,230,2.34201358403347,0.811445694242303 +-149.0983,58.8503341,13.719616,281713.523800345,994147.751581796,229.425277709961,230,2.36064126607249,0.879106752277814 +-149.03409,58.8478746,13.719616,285417.542723058,994147.756481058,254.905639648438,230,2.40637944410443,1.04524086986554 +-148.96989,58.8453831,13.719616,289121.521919212,994147.752817178,255.486480712891,230,2.40736792401229,1.04883131103116 +-148.90569,58.8428597,13.719616,292826.04105549,994147.795470059,260.870330810547,230,2.41642468892023,1.08172806623487 +-148.84151,58.8403043,13.719616,296529.960441488,994147.785323437,276.149597167969,230,2.44114441403496,1.17151716356357 +-148.77734,58.837717,13.719616,300233.859717642,994147.776730921,283.798248291016,230,2.45300971050168,1.21461530702346 +-148.71318,58.8350978,13.719616,303937.745685701,994147.769381576,270.741638183594,230,2.43255505238211,1.14031815039253 +-148.64903,58.8324467,13.719616,307641.625144986,994147.762980971,285.882873535156,230,2.45618813873692,1.22616026558759 +-148.58489,58.8297637,13.719616,311345.504892384,994147.757251164,298.858764648438,230,2.47546599693609,1.29618294901554 +-148.52075,58.8270487,13.719616,315049.966325609,994147.788230255,289.913360595703,230,2.46226823018523,1.24824489315875 +-148.45663,58.8243019,13.719616,318753.867040689,994147.783632669,282.385101318359,230,2.45084177954014,1.20674076298205 +-148.39252,58.8215232,13.719616,322457.78841955,994147.778970773,280.168426513672,230,2.44741919103718,1.1943089446353 +-148.32842,58.8187126,13.719616,326161.737248996,994147.774032427,279.069061279297,330,2.44571169152101,1.18810681902367 +-148.26433,58.8158701,13.719616,329865.720313241,994147.768621882,302.280731201172,330,2.48041046408249,1.3141426649827 +-148.20025,58.8129958,13.719616,333569.74341896,994147.773694876,387.308532714844,330,2.58805706494413,1.70514584471103 +-148.13618,58.8100896,13.719616,337273.814298535,994147.777951457,529.869750976562,430,2.72416912736688,2.19954370568093 +-137.37206,57.846048,13.66239178,974361.640502857,994147.740233851,667.220031738281,440,2.82426907651278,2.56313529234885 +-137.31147,57.837817,13.719616,978065.784075705,994147.774671186,240.00212097168,241,2.38021507972088,0.950204430371413 +-137.25091,57.8295567,13.719616,981769.832444569,994147.791093003,231.871459960938,241,2.36524729652821,0.895837169584979 +-137.19038,57.821267,13.719616,985473.793576783,994147.77745986,325.669372558594,340,2.51277691744041,1.43170686188421 +-137.12988,57.812948,13.719616,989177.669859161,994147.743375794,373.086791992188,340,2.57180987443229,1.64613141136217 +-137.0694,57.8045997,13.719616,992882.040132066,994147.83714218,376.939605712891,340,2.57627177193855,1.66233829665723 +-137.00896,57.7962222,13.719616,996585.759356848,994147.769918167,367.438354492188,340,2.56518448750304,1.62206611496143 +-136.94854,57.7878154,13.719616,1000289.98285088,994147.829278817,398.798950195312,350,2.60075400639743,1.75126476013732 +-136.88816,57.7793793,13.719616,1003993.56838998,994147.713367969,501.488220214844,350,2.70026073604881,2.11270160427941 +-136.76747,57.7624196,13.719616,1011401.70308114,994147.749055808,555.472900390625,450,2.74466287606195,2.27398285043967 +-136.70717,57.753896,13.719616,1015105.68872257,994147.747721386,168.929733276367,250,2.22770609635243,0.396248272379522 +-136.6469,57.7453432,13.719616,1018809.62762725,994147.728480935,131.1572265625,150,2.11779222454706,-0.0029902825599888 +-136.58666,57.7367613,13.719616,1022513.52198043,994147.700994385,142.774841308594,150,2.15465168612737,0.130893802637453 +-136.52644,57.7281503,13.719616,1026217.9505092,994147.818662121,131.714111328125,150,2.11963230604482,0.00369341865140538 +-136.46626,57.7195102,13.719616,1029921.77088814,994147.771877222,116.960243225098,150,2.06803826275339,-0.183710872989149 +-136.40611,57.710841,13.719616,1033625.56183213,994147.71350313,83.5657653808594,50,1.92202839524697,-0.714060387137781 +-136.34598,57.7021428,13.719616,1037329.89911587,994147.809420625,65.0430297851562,50,1.81320076303386,-1.10935340983456 +-136.28589,57.6934155,12.17062895,1041033.64331014,994147.735925785,38.2154426574707,50,1.58223889447401,-1.94827283952441 +-153.28684,58.9082802,13.719616,40954.0651674831,990443.779370945,27.1241912841797,32,1.43335679843063,-2.48905510753491 +-153.22235,58.9079083,13.719616,44657.8050129512,990443.777596741,132.123153686523,132,2.12097893144617,0.00858474647430075 +-153.15786,58.9075042,13.719616,48361.629122189,990443.773804547,163.394546508789,132,2.21323755733309,0.343694408929102 +-153.09337,58.9070679,13.719616,52065.5444865433,990443.768209927,165.316482543945,132,2.21831615617895,0.362141329513696 +-153.02888,58.9065995,13.719616,55769.5579335082,990443.772222719,162.049423217773,132,2.2096474895874,0.330654258169381 +-152.96439,58.9060989,13.719616,59473.6765953481,990443.774915437,162.803268432617,132,2.21166311952125,0.337975601407203 +-152.8999,58.9055661,13.719616,63177.9074621202,990443.77655511,166.263595581055,132,2.22079716822726,0.371153073424503 +-152.83542,58.9050012,13.719616,66881.6830875041,990443.77853163,175.813995361328,132,2.24505344335591,0.459258788121957 +-152.77094,58.904404,13.719616,70585.5850815846,990443.767748456,176.969909667969,132,2.24789942920879,0.469596221064859 +-152.70646,58.9037748,13.719616,74289.6198122644,990443.778053125,161.949951171875,132,2.20938082140585,0.329685643219344 +-152.64198,58.9031133,13.719616,77993.7948880384,990443.776252206,165.440338134766,132,2.2186414090463,0.363322740764314 +-152.57751,58.9024197,13.719616,81697.542610044,990443.772748707,178.883850097656,132,2.25257113357984,0.486565184777671 +-152.51303,58.9016939,13.719616,85402.0186623959,990443.780782289,162.874877929688,132,2.2118541032288,0.338669308745215 +-152.44857,58.900936,13.719616,89105.5070503272,990443.773336463,164.01496887207,132,2.21488348586403,0.349672891148242 +-152.3841,58.9001459,13.719616,92809.7377181471,990443.778218387,72.3733596801758,132,1.85957873369686,-0.940895382795801 +-152.31964,58.8993236,10.74948118,96513.5691706338,990443.768456997,48.5494079589844,132,1.6861839382252,-1.57071477175081 +-152.25518,58.8984692,12.3526437,100217.582337775,990443.769082347,38.4952812194824,132,1.58540749662695,-1.93676357209584 +-152.19072,58.8975827,12.48896976,103921.784169998,990443.780549078,32.7416648864746,132,1.51510075915122,-2.19213771014844 +-152.12627,58.896664,13.719616,107625.607692377,990443.775949115,91.6942138671875,132,1.96234193147335,-0.567630116934753 +-152.06182,58.8957131,13.719616,111329.634126069,990443.770862669,51.7154197692871,132,1.71362005416257,-1.47105896761917 +-151.99737,58.8947301,13.68280175,115033.870114439,990443.776969675,45.8082542419434,132,1.66094374107673,-1.66239437206358 +-151.93293,58.893715,13.719616,118737.748364556,990443.776913823,44.463695526123,132,1.64800555552682,-1.70938955490664 +-151.86849,58.8926677,13.719616,122441.85042101,990443.776826332,105.085861206055,132,2.02154428773849,-0.352590260944946 +-151.80406,58.8915883,13.719616,126145.60865192,990443.769442646,108.05485534668,132,2.03364428628539,-0.308639612539182 +-151.73963,58.8904768,13.719616,129849.604241178,990443.773216013,141.806991577148,132,2.15169764360108,0.120163877014285 +-151.6752,58.8893331,13.719616,133553.844522996,990443.777566146,133.587142944336,132,2.12576466160492,0.0259678843942596 +-151.61078,58.8881573,13.719616,137257.761829854,990443.773605315,105.61743927002,132,2.02373563366581,-0.344630667064517 +-151.54636,58.8869494,13.719616,140961.937342451,990443.781511059,121.570747375488,132,2.08482908659998,-0.122721808200055 +-151.48195,58.8857094,13.719616,144665.803760594,990443.780142106,133.619995117188,132,2.12587145154746,0.0263557759464475 +-151.41754,58.8844372,13.719616,148369.942697258,990443.779655788,157.234375,132,2.19654749870594,0.283071352178287 +-151.35314,58.883133,13.719616,152073.785991615,990443.780169174,135.481140136719,132,2.13187884277775,0.0481763355749988 +-151.28874,58.8817966,13.719616,155777.915699622,990443.781819798,145.96728515625,132,2.16425553066002,0.165777707190192 +-151.22435,58.8804281,13.719616,159481.764081716,990443.772473127,161.265151977539,132,2.20754053019777,0.323001180280179 +-151.15996,58.8790275,13.719616,163185.912311369,990443.775755101,179.068023681641,132,2.253018040464,0.488188478140864 +-151.09558,58.8775949,13.719616,166889.792592286,990443.778447364,172.106689453125,132,2.23579775083958,0.425639471064988 +-151.0312,58.8761301,13.719616,170593.987061887,990443.782989943,172.27864074707,132,2.23623143658502,0.427214741478641 +-150.96683,58.8746333,13.719616,174297.927421639,990443.786249814,150.023666381836,131,2.17615977484434,0.209017319877205 +-150.90247,58.8731043,13.719616,178001.62160961,990443.765015314,157.02033996582,131,2.19595591331852,0.280922545195883 +-150.83811,58.8715433,13.719616,181705.649760903,990443.76811816,157.627151489258,131,2.1976310274069,0.287007037690047 +-150.77375,58.8699502,13.719616,185410.019311174,990443.785220656,147.619766235352,131,2.16914451326069,0.183535887450388 +-150.70941,58.868325,13.719616,189113.58870448,990443.760215962,131.571868896484,131,2.11916304361685,0.00198892357221443 +-150.64507,58.8666678,13.719616,192817.512778413,990443.759851993,131.997970581055,131,2.12056725414354,0.00708941700673608 +-150.58073,58.8649785,13.719616,196521.798996539,990443.773843313,143.479232788086,131,2.15678904575141,0.138657302855142 +-150.5164,58.8632572,13.719616,200225.879452067,990443.784099455,139.130859375,131,2.14342346766187,0.0901097083181376 +-150.45208,58.8615038,13.719616,203929.761627014,990443.778696654,148.722366333008,131,2.17237628691172,0.195274611790943 +-150.38776,58.8597183,13.719616,207634.026677175,990443.788156711,157.453247070312,131,2.19715162127728,0.285265697791146 +-150.32346,58.8579008,13.719616,211337.532418548,990443.760942097,157.848068237305,131,2.19823927131526,0.289216353175324 +-150.25915,58.8560513,13.719616,215042.008450901,990443.791809598,159.339904785156,131,2.20232455331346,0.304055263448339 +-150.19486,58.8541697,13.719616,218745.739573135,990443.773437133,164.496429443359,131,2.21615647559982,0.354296753216075 +-150.13057,58.8522561,13.719616,222449.88052316,990443.781626515,169.295166015625,131,2.22864455762038,0.399657031568248 +-150.06629,58.8503105,13.719616,226153.863935989,990443.783336463,182.058929443359,131,2.26021198463153,0.514318936713448 +-150.00202,58.8483328,13.719616,229857.69735721,990443.766765215,191.763336181641,131,2.28276557668201,0.596240020476858 +-149.93775,58.8463232,13.719616,233561.960563709,990443.788770557,219.415145874023,230,2.34126660292183,0.808732445635183 +-149.8735,58.8442815,13.719616,237265.513300921,990443.756646782,240.436798095703,230,2.381000935822,0.953058884036347 +-149.80925,58.8422079,13.719616,240969.509538664,990443.763009299,242.920028686523,230,2.38546332373654,0.969267550634252 +-149.745,58.8401022,13.719616,244673.957541473,990443.786642273,242.401596069336,230,2.38453547507273,0.965897339452916 +-149.68077,58.8379646,13.719616,248377.71427261,990443.776168955,242.7685546875,230,2.38519243277343,0.968283597336262 +-149.61654,58.8357949,13.719616,252081.936515577,990443.782978925,232.171951293945,230,2.36580975143162,0.897880166334746 +-149.55232,58.8335933,13.719616,255786.055426356,990443.792010525,227.367584228516,230,2.35672854744853,0.864894641434522 +-149.48812,58.8313597,13.719616,259489.504349091,990443.752525925,217.411254882812,230,2.33728202276306,0.794259313186123 +-149.42391,58.8290942,13.719616,263194.012089269,990443.792402595,214.485580444336,230,2.33139810051163,0.772887228130306 +-149.35972,58.8267967,13.719616,266897.863528675,990443.782790882,206.246704101562,230,2.31438701709134,0.71109811770121 +-149.29554,58.8244672,13.719616,270601.639758415,990443.76230373,207.873275756836,230,2.31779865990696,0.723490178187369 +-149.23136,58.8221058,13.719616,274305.921065513,990443.782950524,206.883148193359,230,2.31572511635593,0.71595847616176 +-149.1672,58.8197125,13.719616,278009.565784779,990443.762251075,211.326141357422,230,2.32495322324755,0.749477594356082 +-149.10304,58.8172872,13.719616,281713.730031791,990443.771811284,224.044219970703,230,2.35033374419993,0.841666890777008 +-149.03889,58.81483,13.719616,285417.845574853,990443.781079508,233.338195800781,230,2.3679858355265,0.905784324883603 +-148.97475,58.8123409,13.719616,289121.919221812,990443.789675901,247.984191894531,230,2.39442399698835,1.0018152735156 +-148.91062,58.8098198,13.719616,292825.958633969,990443.786092293,249.131378173828,230,2.39642843050529,1.00909594817143 +-148.8465,58.8072669,13.719616,296529.968913793,990443.792272416,263.016967773438,230,2.41998376663681,1.09465565236339 +-148.78239,58.804682,13.719616,300233.958584416,990443.785597115,265.60498046875,230,2.42423621440764,1.11010175643648 +-148.71829,58.8020653,13.719616,303937.93270053,990443.788039709,261.891387939453,230,2.41812121728026,1.08789034147589 +-148.6542,58.7994167,13.719616,307641.898924717,990443.788158831,259.064788818359,230,2.41340838920713,1.07077200473924 +-148.59012,58.7967362,13.719616,311345.864050604,990443.785673572,277.369415283203,230,2.44305857099093,1.17846992798242 +-148.52605,58.7940238,13.719616,315049.834869344,990443.780319476,283.188049316406,230,2.45207492195046,1.21121988819024 +-148.46199,58.7912796,13.719616,318753.817238578,990443.78298717,283.642303466797,230,2.45277100363402,1.21374825554642 +-148.39794,58.7885035,13.719616,322457.818853959,990443.782304511,279.909210205078,230,2.44701718883928,1.19284875790966 +-148.3339,58.7856955,13.719616,326161.846499059,990443.778056268,275.568939208984,330,2.44023026443171,1.16819671128027 +-148.26987,58.7828557,13.719616,329865.905991638,990443.781179459,314.474670410156,330,2.49758567062673,1.37652791744339 +-148.20585,58.7799841,13.719616,333570.004077864,990443.791488768,392.875701904297,330,2.59425516992864,1.72765913113004 +-137.2665,57.797443,13.09124584,981769.698107453,990443.748477569,479.5498046875,341,2.68083371844663,2.04213713132543 +-137.20602,57.7891607,13.719616,985473.740441023,990443.764890002,421.170837402344,241,2.62445829225298,1.83736549224146 +-137.14557,57.780849,13.719616,989177.696872872,990443.746704691,500.330413818359,341,2.69925690334717,2.1090553973847 +-137.08515,57.7725081,13.719616,992881.566961755,990443.714335626,472.804534912109,440,2.67468163343551,2.01979100258515 +-137.02475,57.764138,13.719616,996585.930069611,990443.816637431,501.932708740234,440,2.70064549765962,2.11409916827177 +-136.96439,57.7557386,13.719616,1000289.64566647,990443.74203993,580.679138183594,450,2.76393622359748,2.34398914984978 +-136.72322,57.721849,13.719616,1015105.57203138,990443.712768997,428.401794433594,351,2.63185128127974,1.8642189385558 +-136.663,57.7133038,13.719616,1018809.55220644,990443.714312166,178.311645507812,250,2.25117970781149,0.481511129234595 +-136.6028,57.7047294,13.719616,1022514.06106657,990443.847377351,147.42512512207,150,2.1685715050427,0.181454558049809 +-136.54264,57.6961259,13.719616,1026217.95230354,990443.814248071,143.367858886719,150,2.15645179936038,0.137432327703217 +-136.48251,57.6874934,13.719616,1029921.80228369,990443.777994215,135.899658203125,150,2.13321836445374,0.0530418606397447 +-136.42241,57.6788318,13.719616,1033625.61893158,990443.726716873,111.20166015625,150,2.0461112709809,-0.263355965693374 +-136.36233,57.6701412,13.719616,1037329.97858188,990443.826289837,83.4276275634766,50,1.9213098937008,-0.716670189834222 +-136.30229,57.6614216,13.71799891,1041033.73774565,990443.763775012,43.6154594421387,50,1.63964045166304,-1.73977399977827 +-136.24227,57.652673,11.52536102,1044738.04988732,990443.851038068,28.4921779632568,50,1.45472564830131,-2.41143734552764 +-153.2231,58.8747746,13.68754011,44658.0637832763,986739.779086222,121.410781860352,32,2.08425725588697,-0.12479886056644 +-153.15867,58.8743709,13.719616,48362.0348725547,986739.7791675,173.050704956055,132,2.23817337281767,0.434268408159425 +-153.09425,58.8739351,13.719616,52065.5221331946,986739.777646823,166.411209106445,132,2.22118257609606,0.372552984810337 +-153.02982,58.8734671,13.719616,55769.6822785359,986739.778701209,160.572998046875,132,2.20567251612836,0.316216019995788 +-152.96539,58.8729669,13.719616,59473.9474978926,986739.775297864,160.898406982422,132,2.206551744272,0.319409627570191 +-152.90097,58.8724347,13.719616,63177.7496101647,986739.780543193,163.412490844727,132,2.21328524985618,0.343867641785755 +-152.83655,58.8718702,13.719616,66881.6709213412,986739.769588331,171.711898803711,132,2.23480039070981,0.422016774398723 +-152.77213,58.8712737,13.719616,70585.7178294199,986739.776263017,181.058319091797,132,2.25781848415253,0.50562505980065 +-152.70771,58.870645,13.719616,74289.8976892622,986739.778531957,182.094573974609,132,2.26029700494926,0.514627754774654 +-152.6433,58.8699842,13.719616,77993.6424592301,986739.7761617,177.991622924805,132,2.25039956296539,0.478677420478047 +-152.57889,58.8692912,13.719616,81697.5341273074,986739.768956724,193.503982543945,132,2.28668990774801,0.610494311024168 +-152.51448,58.8685661,13.719616,85401.5794265424,986739.768461374,177.01579284668,132,2.24801201461152,0.470005163382624 +-152.45007,58.8678089,13.719616,89105.7853068065,986739.775061123,179.907867431641,132,2.2550501556048,0.49556970035567 +-152.38567,58.8670196,13.719616,92809.5839196631,986739.775183469,85.0032424926758,132,1.92943549241804,-0.687155696016444 +-152.32127,58.8661981,13.719616,96513.5572936975,986739.770933069,35.7358932495117,132,1.55310464213847,-2.05409675975059 +-152.25687,58.8653445,13.719616,100217.712115734,986739.773921537,45.6719856262207,132,1.65964989331852,-1.66709399642232 +-152.19247,58.8644588,13.719616,103922.055332657,986739.784602583,82.6068496704102,132,1.91701606004104,-0.732266619268626 +-152.12808,58.863541,13.719616,107626.019092918,986739.787240851,72.6625366210938,132,1.86131055484399,-0.934604914078455 +-152.0637,58.862591,13.719616,111329.610667596,986739.769477616,93.8716583251953,132,1.97253449012664,-0.530607834660107 +-151.99931,58.861609,13.719616,115033.985955348,986739.787134189,114.963104248047,132,2.06055848215814,-0.210879571053018 +-151.93493,58.8605948,13.719616,118738.00296692,986739.784300958,89.4233245849609,132,1.95145081205475,-0.607189771298073 +-151.87056,58.8595485,13.719616,122441.668318919,986739.771016744,97.6097412109375,132,1.98949316134549,-0.469009100306572 +-151.80619,58.8584701,13.719616,126145.563750452,986739.765158861,108.118087768555,132,2.0338983559417,-0.307716759028748 +-151.74182,58.8573596,13.719616,129849.696202009,986739.767300088,105.512504577637,132,2.02330393211951,-0.346198730300564 +-151.67745,58.8562171,13.719616,133554.072222207,986739.789201374,121.05606842041,132,2.08298656507424,-0.129414372289552 +-151.6131,58.8550424,13.719616,137257.549925063,986739.767791037,143.151626586914,132,2.15579628713727,0.135051320207081 +-151.54874,58.8538356,13.719616,140961.860260702,986739.775194868,133.229690551758,132,2.12460101917293,0.0217412029446377 +-151.48439,58.8525968,13.719616,144665.860146758,986739.78132999,135.189834594727,132,2.13094403668406,0.0447808530225273 +-151.42005,58.8513258,13.719616,148369.557354043,986739.762840676,138.938949584961,132,2.14282401117012,0.0879323112381989 +-151.35571,58.8500228,13.719616,152073.532756564,986739.763966638,119.220756530762,132,2.07635187337412,-0.153513466273924 +-151.29137,58.8486877,13.719616,155777.793710245,986739.774229584,131.19140625,132,2.11790538732286,-0.00257924305840408 +-151.22704,58.8473205,13.719616,159481.772348848,986739.770323761,136.725219726562,132,2.13584862998748,0.0625957358108485 +-151.16271,58.8459213,13.719616,163186.049922669,986739.787041248,150.680160522461,132,2.17805607419371,0.215905220371822 +-151.09839,58.84449,13.719616,166890.059018668,986739.788826031,163.488388061523,132,2.21348691185935,0.34460013574133 +-151.03408,58.8430266,13.719616,170593.806564295,986739.774764266,175.247116088867,132,2.243650879837,0.454164277089801 +-150.96977,58.8415312,13.719616,174297.873773407,986739.781370568,169.964614868164,131,2.23035851451308,0.405882612214528 +-150.90547,58.8400037,13.719616,178001.693261312,986739.771467859,158.587371826172,131,2.20026860186834,0.296587460972689 +-150.84117,58.8384442,13.719616,181705.846217422,986739.782718999,173.182113647461,131,2.23850303580295,0.435465838217163 +-150.77688,58.8368526,13.719616,185409.765275792,986739.776866201,161.845199584961,131,2.20909982252339,0.328664975073178 +-150.71259,58.835229,13.719616,189114.031601283,986739.792720504,156.137786865234,131,2.19350801927724,0.272031095339436 +-150.64832,58.8335733,13.719616,192817.503048955,986739.761909434,154.988052368164,131,2.19029822081179,0.260372191145217 +-150.58404,58.8318856,13.719616,196521.910354232,986739.78190236,169.802337646484,131,2.22994366482419,0.404375759734588 +-150.51978,58.8301659,13.719616,200225.536007557,986739.764816868,172.602966308594,131,2.23704825511259,0.430181659513997 +-150.45552,58.8284141,13.719616,203929.537082148,986739.758468614,150.37663269043,131,2.17718035565693,0.21272436069129 +-150.39126,58.8266304,13.719616,207633.919276279,986739.786108267,146.405822753906,131,2.16555834953387,0.170509917201547 +-150.32702,58.8248146,13.719616,211337.541076511,986739.762710501,149.96565246582,131,2.17599180137108,0.208407192277937 +-150.26278,58.8229668,13.719616,215041.558358499,986739.761811503,154.189865112305,131,2.18805582851096,0.252227182266127 +-150.19854,58.821087,13.719616,218745.97799724,986739.784387996,161.876205444336,131,2.20918301550023,0.328967155710675 +-150.13432,58.8191752,13.719616,222449.65727076,986739.764441628,162.855117797852,131,2.21180141102151,0.338477915608466 +-150.0701,58.8172315,13.719616,226153.751984708,986739.778901606,168.435363769531,131,2.22643327883574,0.391625035860603 +-150.00589,58.8152557,13.719616,229857.695522471,986739.771866561,179.196014404297,131,2.25332834605451,0.489315596615646 +-149.94168,58.8132479,13.719616,233562.06889923,986739.789034865,198.768936157227,131,2.29834851331264,0.652841694132252 +-149.87749,58.8112082,13.719616,237265.728692315,986739.771169313,226.787826538086,230,2.35561973889271,0.860867132274303 +-149.8133,58.8091365,13.719616,240969.832032883,986739.777412272,238.022552490234,230,2.37661810814071,0.937139202914328 +-149.74912,58.8070328,13.719616,244673.810985477,986739.772015194,234.195938110352,230,2.36957935840689,0.911572454821893 +-149.68495,58.8048972,13.719616,248377.671684553,986739.765569347,228.416748046875,230,2.35872794422213,0.872157021200871 +-149.62078,58.8027296,13.719616,252081.996490143,986739.784330985,220.906845092773,230,2.3442091732728,0.819420701043099 +-149.55663,58.8005301,13.719616,255785.641915937,986739.763565382,215.052551269531,230,2.33254459916031,0.777051638465627 +-149.49248,58.7982987,13.719616,259489.764379019,986739.779230889,207.532974243164,230,2.3170871101764,0.720905626469439 +-149.42834,58.7960353,13.719616,263193.796670416,986739.781720198,198.04084777832,230,2.29675477680234,0.647052788229133 +-149.36421,58.7937399,13.719616,266897.745640137,986739.770553749,195.549850463867,230,2.29125748818515,0.627085066889107 +-149.30009,58.7914127,13.719616,270601.616555318,986739.767567713,193.923080444336,230,2.28762950125554,0.613907182830197 +-149.23597,58.7890535,13.719616,274305.992596988,986739.791317764,194.327239990234,131,2.28853368247448,0.617191427096427 +-149.17187,58.7866624,13.719616,278009.730201566,986739.77047137,204.586029052734,230,2.31087597291245,0.698345003091707 +-149.10777,58.7842394,13.719616,281713.985773329,986739.787779141,221.191329956055,230,2.34476809991097,0.821450882126486 +-149.04369,58.7817845,13.719616,285417.616523861,986739.758560309,230.312393188477,230,2.3623173081273,0.885194615410904 +-148.97961,58.7792978,13.719616,289121.778008781,986739.778974973,252.058395385742,230,2.40150116719365,1.02752157572675 +-148.91554,58.7767791,13.719616,292825.903910303,986739.783945469,239.844116210938,230,2.37992906894131,0.949165557584416 +-148.85148,58.7742286,13.719616,296529.99932929,986739.795412383,245.224792480469,230,2.38956437568795,0.984163741878529 +-148.78743,58.7716462,13.719616,300234.071907497,986739.801897012,245.450119018555,230,2.38996324702497,0.9856125564238 +-148.7234,58.7690319,13.719616,303937.553642517,986739.757316508,261.770233154297,230,2.41792025981663,1.08716040660901 +-148.65937,58.7663858,13.719616,307641.600024485,986739.763486401,254.778762817383,230,2.40616322438697,1.04445549813649 +-148.59535,58.7637078,13.719616,311345.643922559,986739.763771442,271.255798339844,230,2.43337903039607,1.14331107372595 +-148.53134,58.760998,13.719616,315049.691205279,986739.769043613,282.71484375,230,2.45134861142364,1.20858172104717 +-148.46734,58.7582563,13.719616,318753.749555941,986739.767910636,287.277191162109,230,2.45830114584692,1.23383531052341 +-148.40335,58.7554829,13.719616,322457.823875777,986739.782413057,278.673583984375,230,2.44509580303858,1.18586973626343 +-148.33937,58.7526776,13.719616,326161.922783855,986739.790053633,269.051696777344,330,2.42983573527385,1.13044081448494 +-148.2754,58.7498405,13.719616,329866.052095661,986739.801766117,265.193420410156,330,2.42356274478926,1.10765552255517 +-148.21145,58.7469716,13.719616,333569.643756557,986739.76713394,366.604949951172,330,2.56419832457046,1.61848408971137 +-148.1475,58.7440709,13.719616,337273.854102131,986739.785883278,510.511535644531,430,2.708005559959,2.14083301531405 +-136.73924,57.6897991,13.719616,1015105.5058693,986739.698788073,524.437377929688,450,2.71969363734701,2.18328744849675 +-136.67907,57.6812613,13.719616,1018809.52823929,986739.700039623,379.778686523438,450,2.5795305881393,1.67417524725711 +-136.61892,57.6726945,13.719616,1022514.07021503,986739.850985221,298.064117431641,250,2.47430969646397,1.2919829356598 +-136.55881,57.6640986,13.719616,1026217.99011528,986739.832314982,171.104782104492,150,2.2332621475456,0.416429436168024 +-136.49873,57.6554736,13.719616,1029921.86777541,986739.796309315,147.053115844727,150,2.1674742310181,0.177468945599264 +-136.43868,57.6468196,13.719616,1033625.70530823,986739.752629013,130.961074829102,150,2.11714223077799,-0.00535124545595894 +-136.37866,57.6381366,13.719616,1037329.50771014,986739.70015732,111.782974243164,150,2.04837566083732,-0.255131055413655 +-136.31866,57.6294246,13.719616,1041033.85476906,986739.794543775,73.0189819335938,50,1.86343577350956,-0.926885513287292 +-136.2587,57.6206836,13.51633621,1044737.60187396,986739.721737652,85.8198471069336,50,1.93358773647638,-0.672073560428107 +-136.19876,57.6119137,12.24779002,1048441.90064048,986739.805491456,40.7462120056152,50,1.61008724052322,-1.84711969796434 +-136.07898,57.5942871,8.823615955,1055849.87671045,986739.798333383,53.3277816772461,50,1.72695351832813,-1.42262802002027 +-135.95932,57.576545,6.168267611,1063257.81651393,986739.78604823,17.5331344604492,50,1.24385956339495,-3.17736315308028 +-153.22386,58.8416403,13.46706711,44657.6634884381,983035.778044865,79.6012725830078,20,1.90092001084521,-0.790732064217708 +-153.15949,58.8412369,13.719616,48361.7750032703,983035.770191542,178.929840087891,132,2.2526827737973,0.486970693912782 +-153.09512,58.8408015,13.719616,52065.9772230355,983035.776610755,166.520706176758,132,2.22146824396359,0.373590612042933 +-153.03076,58.840334,13.719616,55769.7018742747,983035.777959026,156.164474487305,132,2.19358224408098,0.272300701012494 +-152.9664,58.8398343,13.719616,59473.5314371359,983035.770590409,155.937606811523,132,2.19295086477933,0.270007351175294 +-152.90203,58.8393025,13.719616,63178.048065049,983035.775460287,157.271591186523,132,2.19665028075943,0.283444685933488 +-152.83768,58.8387387,13.719616,66881.5324462195,983035.775487807,164.033432006836,132,2.2149323715622,0.349850457957374 +-152.77332,58.8381427,13.719616,70585.7179764922,983035.777159456,183.736404418945,132,2.26419521331119,0.52878716020463 +-152.70896,58.8375146,13.719616,74290.0360645444,983035.782454951,193.606369018555,132,2.28691964008041,0.611328764427598 +-152.64461,58.8368544,13.719616,77993.9183032643,983035.77996373,193.09538269043,132,2.28577188902516,0.607159804994155 +-152.58026,58.8361621,13.719616,81697.9469956372,983035.780665053,197.985458374023,132,2.29663329339366,0.646611525813996 +-152.51592,58.8354377,13.719616,85401.5537333056,983035.772066951,203.889144897461,132,2.3093941044607,0.692962433907578 +-152.45157,58.8346812,13.719616,89105.8961732966,983035.779715475,191.391845703125,132,2.28192343061127,0.593181105575527 +-152.38723,58.8338926,13.719616,92809.8305505311,983035.7777354,146.236587524414,132,2.16505604411317,0.168685400541306 +-152.32289,58.8330719,13.719616,96513.9391652537,983035.779405002,139.742004394531,132,2.14532696828172,0.0970237658826205 +-152.25856,58.8322191,13.719616,100217.653606244,983035.770069419,104.046089172363,132,2.01722576083037,-0.368276383305511 +-152.19423,58.8313342,13.719616,103921.556172198,983035.764156427,116.187805175781,132,2.06516054782374,-0.194163554995241 +-152.1299,58.8304173,13.719616,107625.653490918,983035.773309059,112.111228942871,132,2.0496491132524,-0.25050551276257 +-152.06557,58.8294682,13.719616,111329.953122684,983035.775667004,115.446960449219,132,2.06238250306082,-0.204254206507076 +-152.00125,58.8284871,13.719616,115033.88601268,983035.776758834,107.952461242676,132,2.03323254840186,-0.310135162053836 +-151.93693,58.8274739,13.719616,118738.03477085,983035.782137878,106.062118530273,132,2.02556029765355,-0.338002966650098 +-151.87262,58.8264286,13.719616,122441.830980778,983035.773904777,111.602439880371,132,2.04767368935961,-0.257680816183283 +-151.80831,58.8253513,13.719616,126145.856566962,983035.781107322,123.107055664062,132,2.09028294446792,-0.102911839737677 +-151.74401,58.8242418,13.719616,129849.543837831,983035.762420965,122.055068969727,132,2.08655582045839,-0.116449817967398 +-151.6797,58.8231003,13.719616,133554.049691566,983035.779324324,143.857650756836,132,2.1579329638497,0.142812339894872 +-151.61541,58.8219268,13.719616,137257.654964523,983035.772091235,132.098785400391,132,2.12089882445531,0.0082937750186541 +-151.55112,58.8207212,13.719616,140961.517680826,983035.769277709,90.4510726928711,132,1.95641372168596,-0.589163066962068 +-151.48683,58.8194835,13.719616,144665.644773127,983035.771523083,102.973579406738,132,2.01272580927065,-0.384621491784488 +-151.42254,58.8182138,13.719616,148370.042739222,983035.790652996,102.329078674316,132,2.00999906394958,-0.394525809081211 +-151.35827,58.816912,13.719616,152073.568210808,983035.770372782,104.225036621094,132,2.01797205639451,-0.365565624802616 +-151.29399,58.8155781,13.719616,155777.954183047,983035.778396002,116.361839294434,132,2.06581057738346,-0.191802462097435 +-151.22972,58.8142123,13.719616,159482.055940834,983035.791410198,132.027481079102,132,2.12066433756056,0.00744205168770814 +-151.16546,58.8128143,13.719616,163185.881776733,983035.774960856,129.383880615234,132,2.11188017280933,-0.0244645419390061 +-151.1012,58.8113844,13.719616,166890.012540572,983035.786747955,129.687225341797,132,2.11289719862221,-0.0207704138985298 +-151.03695,58.8099224,13.719616,170593.880733226,983035.779505713,135.009689331055,132,2.13036493791728,0.0426774010103165 +-150.9727,58.8084284,13.719616,174298.06812329,983035.789746928,156.551635742188,131,2.19465760973699,0.276206736015049 +-150.90846,58.8069023,13.719616,178002.006764366,983035.780292987,162.271377563477,131,2.21024192301498,0.33281341004655 +-150.84423,58.8053443,13.719616,181705.702514335,983035.772609089,176.271026611328,131,2.24618093387114,0.463354155491112 +-150.78,58.8037542,13.719616,185409.738665584,983035.771433675,178.860260009766,131,2.25251385775209,0.486357142623157 +-150.71578,58.8021321,13.719616,189113.546227067,983035.760296493,170.131912231445,131,2.23078578337225,0.407434574665699 +-150.65156,58.800478,13.719616,192817.70743709,983035.767415577,157.745529174805,131,2.19795705931252,0.288191278630013 +-150.58735,58.7987919,13.719616,196521.653821717,983035.76407328,176.895477294922,131,2.24771672939945,0.468932603209602 +-150.52314,58.7970738,13.719616,200225.967616152,983035.779636697,179.99284362793,131,2.25525523824395,0.496314619037461 +-150.45895,58.7953238,13.719616,203929.504392241,983035.764760719,173.666137695312,131,2.23971514576015,0.439868567552322 +-150.39475,58.7935417,13.719616,207633.9982733,983035.78849419,150.515731811523,131,2.17758189449379,0.214182864357383 +-150.33057,58.7917276,13.719616,211337.729483329,983035.769145699,136.820938110352,131,2.1361525638312,0.0636997102825899 +-150.26639,58.7898816,13.719616,215041.854978263,983035.78024741,150.416046142578,131,2.17729416856584,0.213137761661898 +-150.20222,58.7880036,13.719616,218745.806880827,983035.778674705,163.629943847656,131,2.21386278135145,0.345965401020487 +-150.13806,58.7860936,13.719616,222449.592060867,983035.763745698,163.087585449219,131,2.21242090294032,0.340728087078183 +-150.0739,58.7841517,13.719616,226153.792081391,983035.780006811,156.584197998047,131,2.19474793225243,0.276534813171742 +-150.00975,58.7821778,13.719616,229857.839092166,983035.782712208,167.799270629883,131,2.22479006875665,0.385656427834522 +-149.94561,58.7801719,13.719616,233561.739957634,983035.771230102,179.003982543945,131,2.25286269342469,0.487624213353652 +-149.88147,58.7781341,13.719616,237266.076202984,983035.791828232,196.123947143555,131,2.29253062516875,0.63170946380303 +-149.81735,58.7760644,13.719616,240969.703945888,983035.773010141,212.92155456543,230,2.32821962834762,0.761342110004367 +-149.75323,58.7739627,13.719616,244673.78143778,983035.775048911,219.199249267578,230,2.34083906240582,0.807179496448835 +-149.68912,58.7718291,13.719616,248377.739455092,983035.772806401,209.911392211914,230,2.32203600904697,0.738881439723714 +-149.62502,58.7696636,13.719616,252081.584820374,983035.765732003,203.709945678711,230,2.30901223296649,0.691575367643626 +-149.56092,58.7674661,13.719616,255785.900456093,983035.780654795,202.041839599609,230,2.30544131412819,0.678604771181208 +-149.49684,58.7652368,13.719616,259489.540987696,983035.762889534,196.298217773438,230,2.29291635658077,0.633110550390205 +-149.43276,58.7629755,13.719616,263193.665446241,983035.767220053,190.029510498047,131,2.27882104964369,0.58191237239357 +-149.36869,58.7606823,13.719616,266897.704544189,983035.765798903,188.300903320312,131,2.27485240342658,0.567497116568605 +-149.30463,58.7583573,13.719616,270601.664304196,983035.769307663,175.946853637695,131,2.24538150498761,0.460450401606398 +-149.24058,58.7560003,13.719616,274305.553104823,983035.754995523,172.331848144531,131,2.23636554555756,0.427701863545449 +-149.17653,58.7536115,13.719616,278009.951519423,983035.78658765,202.546112060547,131,2.30652391117374,0.682537072654607 +-149.1125,58.7511908,13.719616,281713.716432635,983035.769350176,213.136215209961,131,2.32865724947745,0.7629316748574 +-149.04847,58.7487382,13.719616,285418.005358676,983035.787163009,214.844146728516,230,2.3321235261459,0.775522181091062 +-148.98446,58.7462538,13.719616,289121.673544764,983035.765389012,217.962478637695,230,2.33838173799401,0.798253792794926 +-148.92045,58.7437375,13.719616,292825.879322419,983035.77902497,231.373626708984,230,2.36431385406467,0.892446640126369 +-148.85645,58.7411894,13.719616,296530.053268127,983035.795884706,237.726257324219,230,2.37607715304173,0.935174299590858 +-148.79247,58.7386094,13.719616,300233.627664178,983035.759278419,234.712142944336,230,2.37053555861138,0.915045646891298 +-148.72849,58.7359976,13.719616,303937.759126936,983035.769887582,247.045623779297,230,2.39277716510527,0.995833510063655 +-148.66452,58.733354,13.719616,307641.879058377,983035.782755766,248.35514831543,230,2.39507316719739,1.00417324500647 +-148.60056,58.7306786,13.719616,311345.994213423,983035.797593511,255.696914672852,230,2.40772548771097,1.0501300844436 +-148.53662,58.7279713,13.719616,315049.536907644,983035.755549067,254.497665405273,230,2.40568380275821,1.04271410194027 +-148.47268,58.7252322,13.719616,318753.663704719,983035.761827721,281.555236816406,230,2.4495636094583,1.20209808441876 +-148.40875,58.7224614,13.719616,322457.805056863,983035.780444886,283.078765869141,330,2.45190729355541,1.2106110140135 +-148.34483,58.7196587,13.719616,326161.969578106,983035.788900546,282.405731201172,330,2.45087350613255,1.20685600302138 +-148.28093,58.7168243,13.719616,329865.586764947,983035.759590484,299.217224121094,330,2.47598658961169,1.29807389020525 +-148.21703,58.7139581,13.719616,333569.815007789,983035.779968484,349.1416015625,330,2.54300159975257,1.5414915350252 +-148.15315,58.7110601,13.719616,337273.510333089,983035.749960798,503.464172363281,430,2.70196857062241,2.11890494691527 +-136.75522,57.6577462,13.719616,1015106.07297786,983035.849309596,678.438659667969,450,2.83151058748288,2.58943852712526 +-136.63502,57.6406566,13.719616,1022513.5522595,983035.713293694,527.256774902344,450,2.72202216884547,2.19174533952821 +-136.57495,57.6320682,13.719616,1026218.07425096,983035.852770843,529.273803710938,351,2.72368039921452,2.19776850553468 +-136.51492,57.6234508,13.719616,1029921.97186649,983035.828302487,166.675842285156,150,2.22187265848109,0.375059561001899 +-136.45492,57.6148043,13.719616,1033625.82837953,983035.781941529,148.719512939453,150,2.17236795443965,0.195244345874065 +-136.39495,57.6061289,13.719616,1037329.64296341,983035.734126634,133.867614746094,150,2.12667552519573,0.0292764009424138 +-136.335,57.5974245,13.719616,1041033.9988697,983035.829717159,82.6374206542969,50,1.9171767531741,-0.731682935942944 +-136.27509,57.5886912,13.71956516,1044737.74742617,983035.765426744,37.1622695922852,50,1.57010222957635,-1.99235667058176 +-136.2152,57.5799289,13.57091216,1048442.04724702,983035.843454395,22.271089553833,50,1.34774146425642,-2.80003443830492 +-136.15535,57.5711377,13.61420353,1052145.74962841,983035.758297592,19.3675537109375,50,1.28707476904467,-3.02039319131278 +-136.09552,57.5623177,12.40584508,1055850.00724309,983035.835939236,27.083625793457,50,1.4327068046469,-2.49141607048413 +-136.03573,57.5534688,9.332751032,1059553.67726555,983035.747122186,138.358535766602,50,2.14100595727518,0.0813286205675217 +-153.35323,58.8092149,10.53487645,37249.5086620105,979331.773921654,12.8322372436523,20,1.108302380293,-3.66974553397871 +-153.28892,58.8088761,13.719616,40953.5931821905,979331.77052515,25.197826385498,20,1.40136307929353,-2.60526542735747 +-153.22461,58.8085053,13.719616,44657.754399258,979331.777842407,54.0883331298828,20,1.73310359775472,-1.40028917613546 +-153.1603,58.8081023,13.719616,48361.999511857,979331.773716328,193.143737792969,132,2.28588063178684,0.607554789742835 +-153.096,58.8076673,13.719616,52065.7592831541,979331.772874396,171.278732299805,132,2.23370343991671,0.418032336017278 +-153.0317,58.8072002,13.719616,55769.6167044386,979331.771095014,143.873794555664,132,2.15798169792357,0.14298935596126 +-152.9674,58.806701,13.719616,59473.5787229784,979331.768625996,148.700347900391,132,2.1723119846016,0.195041047446891 +-152.9031,58.8061698,13.719616,63177.6521009743,979331.776908286,154.67561340332,132,2.1894218469946,0.257188951299212 +-152.8388,58.8056064,13.719616,66881.8441431509,979331.773871372,164.349105834961,132,2.21576734558224,0.352883321923458 +-152.77451,58.805011,13.719616,70585.5855021843,979331.771537491,175.622497558594,132,2.24458014903998,0.457539648074839 +-152.71021,58.8043835,13.719616,74290.0351341271,979331.779745891,194.271942138672,132,2.28841008184401,0.616742474327404 +-152.64592,58.8037239,13.719616,77994.0481574801,979331.77701444,201.308822631836,132,2.3038628088497,0.672871189459476 +-152.58164,58.8030323,13.719616,81697.6312776132,979331.773194843,201.594543457031,132,2.30447877291946,0.675108546774498 +-152.51735,58.8023086,13.719616,85401.9434812167,979331.78152434,207.56982421875,132,2.31716421753947,0.721185702420761 +-152.45307,58.8015528,13.719616,89105.8398848751,979331.777225358,179.196823120117,132,2.25333030603128,0.489322715810712 +-152.38879,58.800765,13.719616,92809.9030725984,979331.784174839,131.746368408203,132,2.11973865271179,0.0040797001002317 +-152.32452,58.799945,13.719616,96513.5646041305,979331.765908929,115.455215454102,132,2.0624135560646,-0.204141413133949 +-152.26024,58.7990931,13.719616,100217.982400328,979331.784892282,120.209358215332,132,2.07993827850762,-0.140486619167105 +-152.19597,58.798209,13.719616,103922.012420713,979331.778431259,115.856468200684,132,2.06392028521661,-0.198668542790531 +-152.13171,58.7972929,13.719616,107625.661007879,979331.767668502,128.801284790039,132,2.10992019512349,-0.0315837403272761 +-152.06745,58.7963448,13.719616,111329.510980607,979331.768179307,135.728668212891,132,2.13267158776068,0.0510558116249739 +-152.00319,58.7953646,13.719616,115033.569579743,979331.769292771,140.197067260742,132,2.14673892885319,0.102152409691862 +-151.93893,58.7943524,13.719616,118737.843394785,979331.782700633,143.085678100586,132,2.1555961660228,0.13432442319906 +-151.87468,58.7933081,13.719616,122441.76377326,979331.77932958,123.509902954102,132,2.09170178047745,-0.0977582223749443 +-151.81043,58.7922317,13.719616,126145.913562692,979331.777054541,143.751174926758,132,2.15761140301121,0.141644339146885 +-151.74619,58.7911233,13.719616,129849.72340415,979331.768064515,149.482070922852,132,2.17458910592992,0.203312202066489 +-151.68195,58.7899829,13.719616,133553.776110711,979331.771382656,173.989868164062,132,2.24052395903804,0.442806408235907 +-151.61772,58.7888105,13.719616,137257.502668205,979331.766944114,150.367538452148,132,2.17715409029332,0.212628957393789 +-151.55348,58.787606,13.719616,140962.062212328,979331.784976974,145.384048461914,132,2.16251675834553,0.159461989848939 +-151.48926,58.7863695,13.719616,144665.733510466,979331.773611784,144.985473632812,132,2.16132449163399,0.155131336845825 +-151.42504,58.785101,13.719616,148369.675284371,979331.774838083,118.838912963867,132,2.07495867059752,-0.158573976418208 +-151.36082,58.7838004,13.719616,152073.894872527,979331.778157721,119.609565734863,132,2.07776591359671,-0.148377268578212 +-151.29661,58.7824678,13.719616,155777.822832557,979331.771970998,132.192657470703,132,2.12120733330003,0.0094143671998993 +-151.2324,58.7811033,13.719616,159482.041503837,979331.790491045,147.286407470703,132,2.16816266922653,0.179969549672138 +-151.1682,58.7797067,13.719616,163185.982784522,979331.787530856,150.837890625,132,2.1785104504352,0.217555644572814 +-151.10401,58.7782781,13.719616,166889.653109136,979331.773323325,153.820861816406,132,2.1870152402595,0.248447468723381 +-151.03982,58.7768175,13.719616,170593.635278842,979331.772637501,150.558975219727,132,2.1777066500661,0.214636012204764 +-150.97563,58.7753249,13.719616,174297.936180362,979331.786244908,150.824569702148,131,2.17847209496143,0.217416326544345 +-150.91145,58.7738003,13.719616,178001.986785941,979331.78813083,168.441421508789,131,2.22644889785639,0.391681768601714 +-150.84728,58.7722437,13.719616,181705.793979503,979331.777427169,173.301300048828,131,2.23880182065918,0.436551110096671 +-150.78311,58.7706551,13.719616,185409.94055662,979331.781201129,168.424942016602,131,2.22640640651084,0.391527427906461 +-150.71895,58.7690346,13.719616,189113.856933206,979331.782978888,171.022750854492,131,2.23305388766314,0.415672976831617 +-150.6548,58.767382,13.719616,192817.551081974,979331.759614682,167.575820922852,131,2.22421135559905,0.383554376464945 +-150.59065,58.7656975,13.719616,196521.60467921,979331.762226115,176.828018188477,131,2.24755107957176,0.468330915754261 +-150.5265,58.7639811,13.719616,200226.024568981,979331.791700503,185.536865234375,131,2.26843021463661,0.544169893808265 +-150.46237,58.7622326,13.719616,203929.666957829,979331.765204406,192.923690795898,230,2.28538556175575,0.60575655408289 +-150.39824,58.7604522,13.719616,207633.689365668,979331.765167263,172.142486572266,131,2.23588807199327,0.425967543275395 +-150.33412,58.7586399,13.719616,211337.522718627,979331.760703747,136.305603027344,131,2.13451370846742,0.0577469198254377 +-150.27,58.7567956,13.719616,215041.750394793,979331.772315401,144.150100708008,131,2.15881495013676,0.146015965833421 +-150.20589,58.7549194,13.719616,218745.802711015,979331.779195695,154.277359008789,131,2.18830219580376,0.253122058593811 +-150.14179,58.7530112,13.719616,222449.687150392,979331.769500349,165.458145141602,131,2.21868815138697,0.363492522287205 +-150.07769,58.7510711,13.719616,226153.985830911,979331.787773446,163.540100097656,131,2.21362425923391,0.345099020608579 +-150.01361,58.7490991,13.719616,229857.553756947,979331.765812899,161.084091186523,131,2.20705265121332,0.321229064554128 +-149.94953,58.7470951,13.719616,233561.550264706,979331.76049131,164.546157836914,131,2.21628774594545,0.354773564579679 +-149.88545,58.7450592,13.719616,237265.981521318,979331.784020321,176.669647216797,131,2.24716194181823,0.466917456362489 +-149.82139,58.7429914,13.719616,240969.702525598,979331.764901264,184.41520690918,131,2.26579673019072,0.5346043266295 +-149.75733,58.7408918,13.719616,244673.871213268,979331.785713798,193.786270141602,131,2.28732300381398,0.612793896639384 +-149.69328,58.7387602,13.719616,248377.919908774,979331.787852051,196.445175170898,131,2.29324136670656,0.634291079934176 +-149.62924,58.7365967,13.719616,252081.854728505,979331.781918082,193.049209594727,131,2.28566802782305,0.606782551463147 +-149.56521,58.7344013,13.719616,255785.682489663,979331.76737546,186.793685913086,131,2.27136219191843,0.554819672165473 +-149.50118,58.7321741,13.719616,259489.985163935,979331.79392905,181.846664428711,131,2.2597053393006,0.512478656260524 +-149.43717,58.7299149,13.719616,263193.619240679,979331.761182922,178.674163818359,131,2.25206175831247,0.484714988416415 +-149.37316,58.7276239,13.719616,266897.741833214,979331.769656743,168.77131652832,131,2.22729863819022,0.394768268034246 +-149.30916,58.7253011,13.719616,270601.783805149,979331.779804582,163.104141235352,131,2.21246498797362,0.340888216502264 +-149.24517,58.7229463,13.719616,274305.753530171,979331.768873397,166.313690185547,131,2.22092799983483,0.371628291166248 +-149.18119,58.7205598,13.719616,278009.655414239,979331.769871033,181.099884033203,131,2.25791817221491,0.505987155297026 +-149.11721,58.7181413,13.719616,281714.07457155,979331.791351034,179.572708129883,131,2.25424033227979,0.492628190892661 +-149.05325,58.7156911,13.719616,285417.863513031,979331.782067664,186.29768371582,131,2.27020745524143,0.550625338959956 +-148.9893,58.713209,13.719616,289121.606570327,979331.761199615,195.816619873047,131,2.29184954963686,0.629235603072909 +-148.92535,58.7106951,13.719616,292825.885598976,979331.783612508,202.743041992188,230,2.30694595843806,0.684070068782911 +-148.86142,58.7081494,13.719616,296529.555533967,979331.761320551,221.951797485352,230,2.34625866652655,0.826865045524341 +-148.79749,58.7055718,13.719616,300233.775835016,979331.771583267,229.014785766602,230,2.3598635223816,0.876281765202333 +-148.73357,58.7029625,13.719616,303937.975606872,979331.79226891,238.243682861328,230,2.37702139394903,0.938604052079353 +-148.66967,58.7003213,13.719616,307641.587450623,979331.754460485,244.436492919922,230,2.38816604400356,0.979084602077233 +-148.60577,58.6976484,13.719616,311345.768162604,979331.772238347,243.58740234375,230,2.38665482405088,0.973595419863975 +-148.54188,58.6949437,13.719616,315049.949464365,979331.78841851,254.930511474609,230,2.40642181731333,1.04539478145481 +-148.47801,58.6922072,13.719616,318753.562189573,979331.754744109,260.221862792969,230,2.41534378143184,1.07780190171533 +-148.41414,58.689439,13.719616,322457.763969695,979331.777545422,275.373382568359,330,2.43992195929655,1.16707685903033 +-148.35028,58.686639,13.719616,326161.986550929,979331.798016703,283.084228515625,330,2.45191567417106,1.2106414548016 +-148.28644,58.6838072,13.719616,329865.660759357,979331.766276667,341.710052490234,330,2.53365775514299,1.5075520244044 +-148.2226,58.6809437,13.719616,333569.944186659,979331.792047915,503.942352294922,330,2.70238085884208,2.12040249540787 +-136.59107,57.6000348,13.719616,1026217.63040254,979331.733349467,685.154235839844,450,2.8357883470168,2.60497657074658 +-136.53109,57.5914249,13.719616,1029921.54605282,979331.709584028,266.638214111328,250,2.42592239184587,1.1162264341751 +-136.47113,57.582786,13.719616,1033625.98972731,979331.826912187,161.531524658203,150,2.20825729229586,0.325604664804713 +-136.41121,57.5741182,13.719616,1037329.81167205,979331.784256597,146.44856262207,150,2.16568511348183,0.170970360042542 +-136.35132,57.5654214,13.719616,1041033.59569316,979331.724795585,123.374122619629,150,2.09122407718482,-0.0994933770838935 +-136.29145,57.5566957,13.719616,1044737.91974444,979331.815504078,87.1588287353516,50,1.94031138544306,-0.64765134826062 +-136.23162,57.547941,13.719616,1048441.63989997,979331.730433338,71.4545822143555,50,1.85403008430404,-0.961049661132739 +-136.17181,57.5391575,13.719616,1052145.90703322,979331.805211472,117.67650604248,50,2.07068976518347,-0.174079859348963 +-136.11204,57.5303451,13.719616,1055849.57719643,979331.711676204,65.9675521850586,50,1.8193303692973,-1.08708893032194 +-136.05229,57.5215039,12.79314239,1059553.8041644,979331.776926086,19.107759475708,50,1.28120976584189,-3.04169655698386 +-153.35385,58.7760786,12.70809231,37249.838014938,975627.780123531,24.2288398742676,20,1.3843326197394,-2.66712491743517 +-153.2896,58.7757401,13.7058385,40954.0497991532,975627.776068516,25.2936763763428,20,1.4030119576133,-2.59927623066335 +-153.22536,58.7753696,13.719616,44657.7617051677,975627.772849787,94.1183700561523,20,1.97367439744843,-0.526467365905416 +-153.16112,58.7749671,13.719616,48361.5571162581,975627.776272368,185.931442260742,132,2.269352838108,0.547521125599305 +-153.09687,58.7745325,13.719616,52066.0195673363,975627.783212692,166.943084716797,132,2.22256843398316,0.377586816219494 +-153.03263,58.7740658,13.719616,55770.0030608679,975627.778778976,146.251815795898,132,2.16510126679007,0.168849662211654 +-152.9684,58.7735671,13.719616,59473.5143669335,975627.772721392,145.776382446289,132,2.16368716867273,0.16371325422568 +-152.90416,58.7730363,13.719616,63177.713522434,975627.771480878,150.882369995117,132,2.17863849715702,0.218020746814658 +-152.83992,58.7724735,13.719616,66882.0308040577,975627.778116743,161.945648193359,132,2.20936928213314,0.329643729287227 +-152.77569,58.7718787,13.719616,70585.8966507916,975627.782297998,171.628433227539,132,2.23458923788858,0.421249807083019 +-152.71146,58.7712518,13.719616,74289.8946595915,975627.782677084,185.634750366211,132,2.26865927834631,0.545001918583185 +-152.64723,58.7705928,13.719616,77994.0317715766,975627.779586149,204.870025634766,132,2.31147842178002,0.70053326933476 +-152.58301,58.7699018,13.719616,81697.7382179647,975627.772247282,191.032775878906,132,2.28110788642138,0.590218816298346 +-152.51879,58.7691788,13.719616,85401.5973770384,975627.772212235,172.53271484375,132,2.23687145609924,0.429539475034072 +-152.45457,58.7684237,13.719616,89105.6164156756,975627.768688933,142.493026733398,132,2.15379361153536,0.127777030800388 +-152.39035,58.7676366,13.719616,92809.8020014999,975627.773251411,118.817710876465,132,2.07488118107133,-0.158855440495026 +-152.32614,58.7668175,13.719616,96513.58456906,975627.771783,122.80241394043,132,2.089206903863,-0.106820326347315 +-152.26193,58.7659663,13.719616,100217.547786297,975627.766960478,117.201278686523,132,2.06893234993695,-0.180463293140558 +-152.19772,58.7650831,13.719616,103921.698286159,975627.770407841,117.003150939941,132,2.0681975576214,-0.183132268561245 +-152.13351,58.7641679,13.719616,107626.042971665,975627.782591923,129.763092041016,132,2.11315118551344,-0.0198478610145162 +-152.06931,58.7632207,13.719616,111330.012274161,975627.78723265,124.638580322266,132,2.09565249358814,-0.0834081047111535 +-152.00512,58.7622414,13.719616,115033.61343065,975627.771985101,133.25602722168,132,2.12468686145034,0.022053006598032 +-151.94092,58.7612301,13.719616,118738.005969085,975627.782624891,109.304733276367,132,2.03863896882343,-0.290497499936662 +-151.87673,58.7601868,13.719616,122442.043847273,975627.784485671,129.959838867188,132,2.11380916420623,-0.0174578945965015 +-151.81255,58.7591115,13.719616,126145.733963713,975627.776445415,166.497833251953,132,2.22140858611355,0.373373917703534 +-151.74837,58.7580042,13.719616,129849.659686733,975627.776951422,194.510330200195,132,2.28894267111061,0.618676990559809 +-151.68419,58.7568648,13.719616,133553.828302502,975627.775418095,170.734924316406,132,2.23232236637848,0.413015882728801 +-151.62002,58.7556935,13.719616,137257.669467045,975627.774120681,169.95751953125,132,2.23034038409227,0.405816757351212 +-151.55585,58.7544901,13.719616,140961.767335694,975627.770889623,172.92317199707,132,2.23785319336745,0.433105425007919 +-151.49169,58.7532548,13.719616,144665.551519101,975627.766916803,156.080444335938,132,2.19334849275481,0.271451649476553 +-151.42753,58.7519875,13.719616,148369.605780663,975627.772352289,150.739135742188,132,2.17822602092997,0.216522515425548 +-151.36337,58.7506881,13.719616,152073.937454929,975627.776696744,171.314849853516,132,2.2337950099586,0.418364944546116 +-151.29922,58.7493568,13.719616,155777.976084297,975627.779516801,153.914047241211,132,2.18727825830414,0.249402825334326 +-151.23508,58.7479935,13.719616,159481.72899009,975627.768673068,152.956802368164,132,2.18456879590236,0.239561284533506 +-151.17094,58.7465983,13.719616,163185.77905436,975627.77895106,154.204574584961,132,2.1880972575511,0.252377664364955 +-151.10681,58.745171,13.719616,166889.557633411,975627.763622615,156.365539550781,132,2.19414104775229,0.27433043544512 +-151.04268,58.7437118,13.719616,170593.647119898,975627.769788863,161.398193359375,132,2.20789866905739,0.324302042841336 +-150.97855,58.7422206,13.719616,174298.054873066,975627.787052624,162.931274414062,131,2.21200445448541,0.33921542742373 +-150.91444,58.7406975,13.719616,178001.634314011,975627.773759542,169.490539550781,131,2.22914546221134,0.401476460015008 +-150.85033,58.7391423,13.719616,181705.546292317,975627.759757439,173.558013916016,131,2.23944467170464,0.438886128581722 +-150.78622,58.7375553,13.719616,185409.796097304,975627.77936025,173.046524047852,131,2.23816288012828,0.434230295716635 +-150.72212,58.7359363,13.719616,189113.81517394,975627.782598366,180.586822509766,131,2.25668605649747,0.501511759330462 +-150.65803,58.7342853,13.719616,192817.610398282,975627.768652197,182.952285766602,131,2.26233783983859,0.522040649604974 +-150.59394,58.7326024,13.719616,196521.764542684,975627.777473022,198.581771850586,230,2.29793938137979,0.651355610174235 +-150.52986,58.7308875,13.719616,200225.708560737,975627.768634916,201.558685302734,230,2.30440151694097,0.674827931009592 +-150.46578,58.7291407,13.719616,203930.025200113,975627.783236936,195.334320068359,230,2.29077855515079,0.625345445407222 +-150.40172,58.727362,13.719616,207633.568356609,975627.75966789,176.530776977539,131,2.24682043270563,0.465676997789126 +-150.33765,58.7255514,13.719616,211338.074278534,975627.790984785,143.63215637207,131,2.15725168065525,0.140337724875035 +-150.2736,58.7237089,13.719616,215041.820387547,975627.782671544,140.438232421875,131,2.14748535472769,0.104863641519177 +-150.20955,58.7218344,13.719616,218745.967095346,975627.787067881,131.468200683594,131,2.11882071907892,0.000745503141296409 +-150.14551,58.719928,13.719616,222449.944145758,975627.782823215,146.594360351562,131,2.1661172628337,0.172540049836252 +-150.08148,58.7179897,13.719616,226153.758367738,975627.769266245,164.19416809082,131,2.21535772762535,0.351395472587444 +-150.01745,58.7160196,13.719616,229857.99238943,975627.79151052,160.806732177734,131,2.20630422654203,0.318510572526329 +-149.95343,58.7140175,13.719616,233562.077894331,975627.793107499,154.843826293945,131,2.18989389448504,0.258903562520255 +-149.88942,58.7119835,13.719616,237266.021046851,975627.784593168,169.471252441406,131,2.22909603902926,0.401296940910901 +-149.82542,58.7099177,13.719616,240969.827966505,975627.776517452,170.973403930664,131,2.23292855820217,0.415217744456792 +-149.76143,58.70782,13.719616,244673.50615365,975627.757135628,174.802719116211,131,2.24254818395045,0.450158970889104 +-149.69744,58.7056904,13.719616,248377.638896923,975627.763275828,173.175765991211,131,2.23848711728489,0.435408017615939 +-149.63346,58.703529,13.719616,252081.65580698,975627.769250882,168.290908813477,131,2.2260606557335,0.390271562396068 +-149.56949,58.7013357,13.719616,255785.564410548,975627.763367708,162.547546386719,131,2.21098041831845,0.33549583577631 +-149.50552,58.6991105,13.719616,259489.947990291,975627.784177225,160.222366333008,131,2.20472314156712,0.312767620610886 +-149.44157,58.6968535,13.719616,263193.65964776,975627.764735313,154.384048461914,131,2.18860242538539,0.254212578128335 +-149.37762,58.6945647,13.719616,266897.859100121,975627.783254648,148.122146606445,131,2.17061999727815,0.188895266546872 +-149.31368,58.692244,13.719616,270601.977437986,975627.789037726,147.299087524414,131,2.16820005652125,0.180105350997945 +-149.24975,58.6898915,13.719616,274306.020666057,975627.792776338,139.809783935547,131,2.14553756454656,0.0977887116266769 +-149.18583,58.6875072,13.719616,278009.995553455,975627.794028112,139.347091674805,131,2.14409790894624,0.0925594715676823 +-149.12192,58.685091,13.719616,281713.909687347,975627.781220432,140.987747192383,131,2.14918137110957,0.111024057109451 +-149.05802,58.6826431,13.719616,285417.768202723,975627.776237843,145.821990966797,131,2.16382302353854,0.164206717875155 +-148.99413,58.6801633,13.719616,289121.579513245,975627.756394647,154.095245361328,131,2.18778923868471,0.25125885192487 +-148.93024,58.6776518,13.719616,292825.925177334,975627.787697766,168.688583374023,131,2.22708569109273,0.393994783395014 +-148.86637,58.6751085,13.719616,296529.6598422,975627.771012726,191.475921630859,131,2.28211416859017,0.593873920356916 +-148.8025,58.6725333,13.719616,300233.944078914,975627.783596464,205.340057373047,230,2.31247367903014,0.704148327741884 +-148.73865,58.6699264,13.719616,303937.62996212,975627.757547879,209.50813293457,230,2.32120088658655,0.735848036579816 +-148.6748,58.6672878,13.719616,307641.877152195,975627.783527336,220.612808227539,230,2.34363072288688,0.817319604135279 +-148.61097,58.6646174,13.719616,311345.540329744,975627.758007079,241.433258056641,230,2.38279709507201,0.959583047107249 +-148.54714,58.6619152,13.719616,315049.779182432,975627.773913562,243.296127319336,230,2.38613519607743,0.971707982747846 +-148.48332,58.6591813,13.719616,318754.023055603,975627.795798249,252.007431030273,230,2.40141334716194,1.02720258830526 +-148.41952,58.6564156,13.719616,322457.70312542,975627.763719906,260.966003417969,330,2.41658393458104,1.08230649192815 +-148.35572,58.6536183,13.719616,326161.977174549,975627.796272656,302.028015136719,330,2.48004722856971,1.31282328992253 +-148.29194,58.6507892,13.719616,329865.700852019,975627.773298835,490.3759765625,330,2.69052918601709,2.07735383690329 +-136.60715,57.5679984,13.719616,1026217.81434767,975627.784571877,598.638916015625,450,2.77716494581771,2.39203964480692 +-136.54722,57.559396,13.719616,1029921.74320108,975627.762574915,241.24609375,250,2.38246028998866,0.958359674910796 +-136.48732,57.5507647,13.719616,1033625.61738625,975627.733375292,186.057006835938,150,2.26964603003013,0.548586082345798 +-136.42744,57.5421044,13.719616,1037330.02126014,975627.841246099,162.783294677734,150,2.2116098342047,0.337782053928362 +-136.3676,57.5334152,13.719616,1041033.80393978,975627.783994991,145.808303833008,150,2.16378225790625,0.164058645462988 +-136.30779,57.524697,13.719616,1044737.54978943,975627.705363147,124.457496643066,150,2.09502106127133,-0.0857016471145184 +-136.248,57.51595,13.719616,1048441.83435763,975627.7836536,87.6130447387695,50,1.94256877324906,-0.639451871426628 +-136.18825,57.5071742,13.719616,1052145.50961524,975627.702566165,82.9278335571289,50,1.91870031983217,-0.726148906971625 +-136.12852,57.4983694,13.719616,1055849.73934796,975627.755767973,50.777702331543,50,1.70567304535007,-1.49992477192831 +-136.06882,57.4895359,13.719616,1059553.94310798,975627.816594341,51.0949172973633,50,1.70837770053598,-1.49010069230764 +-136.00916,57.4806736,12.81709059,1063257.55227794,975627.713090683,18.7144012451172,50,1.27217593670818,-3.07451000290903 +-153.29029,58.7426034,13.7167761,40953.8535739432,971923.77181415,26.9382057189941,20,1.43036866516978,-2.49990886043647 +-153.22611,58.7422333,13.719616,44657.6852630488,971923.775335944,124.737579345703,20,2.0959973118892,-0.082155626220746 +-153.16193,58.7418311,13.719616,48361.6004689673,971923.771163405,178.608169555664,132,2.25190131968019,0.484132229510237 +-153.09775,58.7413969,13.719616,52065.6059808008,971923.770685596,164.100387573242,132,2.21510960677352,0.350494226832838 +-153.03357,58.7409307,13.719616,55769.7087066985,971923.774131912,99.1471633911133,132,1.99628029351652,-0.444356299021014 +-152.96939,58.7404325,13.719616,59473.9155543859,971923.781748682,146.691665649414,132,2.16640543991492,0.173586791249162 +-152.90522,58.7399022,13.719616,63177.6565868204,971923.773110284,146.44677734375,132,2.16567981919122,0.170951129667927 +-152.84105,58.7393399,13.719616,66881.5155767136,971923.76807053,157.188339233398,132,2.19642032545386,0.28260942262788 +-152.77687,58.7387456,13.719616,70586.0764589097,971923.777555042,166.882629394531,132,2.22241113385894,0.377015457270403 +-152.71271,58.7381193,13.719616,74289.6150534433,971923.769991874,181.472595214844,132,2.2588110500576,0.509230342474397 +-152.64854,58.737461,13.719616,77993.8693511798,971923.77759772,200.028213500977,132,2.3010912561821,0.662804119090853 +-152.58438,58.7367707,13.719616,81697.6921995438,971923.777789814,194.47216796875,132,2.28885745572603,0.618367463960145 +-152.52022,58.7360483,13.719616,85401.6677800637,971923.770944699,190.650466918945,132,2.28023787323452,0.587058680077166 +-152.45606,58.735294,13.719616,89105.802508738,971923.779792833,156.457855224609,132,2.19439737250018,0.275261480091837 +-152.39191,58.7345076,13.719616,92809.5267684247,971923.768409021,123.68920135498,132,2.09233178534732,-0.0954698648662872 +-152.32775,58.7336892,13.719616,96514.0012690792,971923.775775227,113.413246154785,132,2.05466378115274,-0.2322908076198 +-152.2636,58.7328389,13.719616,100218.078562452,971923.784989025,110.002075195312,132,2.04140087822524,-0.280465456661862 +-152.19946,58.7319565,13.719616,103921.766122478,971923.772479246,124.203002929688,132,2.09413209616284,-0.0889306221244617 +-152.13532,58.7310422,13.719616,107625.647282021,971923.775590818,125.841651916504,132,2.09982441061264,-0.0682545112945038 +-152.07118,58.7300958,13.719616,111329.729556529,971923.772460682,132.798736572266,132,2.12319394323755,0.016630301527866 +-152.00704,58.7291175,13.719616,115034.019205417,971923.785933475,153.187591552734,132,2.18522358815281,0.241939676883451 +-151.94291,58.7281071,13.719616,118737.946756947,971923.776301827,122.894668579102,132,2.0895330427164,-0.105635696942477 +-151.87879,58.7270648,13.719616,122441.51842555,971923.764769576,122.85230255127,132,2.08938330062839,-0.106179602946785 +-151.81466,58.7259905,13.719616,126145.895498721,971923.777030819,163.314102172852,132,2.21302368768474,0.342917573321801 +-151.75054,58.7248842,13.719616,129849.930813318,971923.776220779,169.296508789062,132,2.22864800223605,0.399669543395553 +-151.68643,58.723746,13.719616,133553.63087302,971923.772420209,175.245208740234,132,2.24364615305169,0.454147108056392 +-151.62232,58.7225757,13.719616,137257.580366136,971923.762883347,176.290664672852,132,2.24622931520113,0.463529890291038 +-151.55821,58.7213735,13.719616,140961.785394128,971923.770567658,171.458648681641,132,2.23415939659578,0.419688500818647 +-151.49411,58.7201394,13.719616,144665.675785817,971923.774322666,179.463653564453,132,2.25397650497704,0.491669894825234 +-151.43001,58.7188732,13.719616,148369.836290873,971923.773128605,179.371215820312,132,2.25375275189999,0.49085715978392 +-151.36592,58.7175751,13.719616,152073.695914084,971923.767092008,184.658843994141,132,2.26637011245206,0.536687014662295 +-151.30183,58.7162451,13.719616,155777.838537906,971923.778679447,178.904220581055,132,2.25262058625458,0.486744811007539 +-151.23775,58.7148831,13.719616,159481.694451188,971923.773409132,175.892395019531,132,2.24524706246797,0.459962068001335 +-151.17367,58.7134891,13.719616,163185.847566239,971923.774897913,177.074569702148,132,2.24815619511982,0.470528868141982 +-151.1096,58.7120632,13.719616,166889.72725063,971923.769917137,169.271774291992,132,2.2285845464657,0.399439053925562 +-151.04553,58.7106054,13.719616,170593.917381739,971923.783231212,151.973693847656,132,2.18176841948735,0.229389518087183 +-150.98147,58.7091156,13.719616,174297.848286311,971923.778196219,171.309829711914,131,2.23378228338094,0.418318717983533 +-150.91742,58.7075939,13.719616,178001.526324134,971923.76508881,179.832458496094,131,2.25486808157688,0.494908355517155 +-150.85337,58.7060402,13.719616,181705.535897842,971923.759232339,188.199630737305,230,2.27461876697164,0.566648482277799 +-150.78932,58.7044547,13.719616,185409.882802711,971923.783772946,190.361541748047,230,2.2795792135146,0.584666239974248 +-150.72528,58.7028372,13.719616,189113.99792149,971923.788739663,200.591751098633,131,2.30231306963153,0.667242094279492 +-150.66125,58.7011878,13.719616,192817.887565103,971923.784473882,203.772918701172,230,2.30914646602889,0.692062940440205 +-150.59723,58.6995064,13.719616,196521.559144771,971923.759006997,207.356094360352,230,2.31671680414747,0.719560569276524 +-150.53321,58.6977932,13.719616,200225.595392196,971923.764023786,205.294326782227,230,2.31237694800081,0.70379697303356 +-150.46919,58.6960481,13.719616,203930.003704706,971923.789261581,192.453826904297,230,2.28432655137186,0.601909926096944 +-150.40519,58.694271,13.719616,207633.637463926,971923.761946782,168.178863525391,131,2.22577141339355,0.389220951659369 +-150.34119,58.6924621,13.719616,211337.656360748,971923.765633256,150.902420043945,131,2.17869620467489,0.218230356990897 +-150.27719,58.6906213,13.719616,215042.067819873,971923.790109913,137.26887512207,131,2.13757207478148,0.068855779222777 +-150.21321,58.6887486,13.719616,218745.724613215,971923.770466995,128.449569702148,131,2.10873265374604,-0.0358972295682613 +-150.14923,58.686844,13.719616,222449.787625242,971923.771333081,132.304977416992,131,2.12157618299379,0.0107541345677897 +-150.08526,58.6849076,13.719616,226153.685994494,971923.77081164,151.122497558594,131,2.17932912243464,0.220529294947028 +-150.02129,58.6829393,13.719616,229858.004210302,971923.791698498,144.240982055664,131,2.15908867059111,0.147010196651198 +-149.95734,58.6809391,13.719616,233561.595037509,971923.764688259,147.655456542969,131,2.16924950076073,0.183917232016936 +-149.89339,58.6789071,13.719616,237265.618662702,971923.770093011,162.27799987793,131,2.21025964626342,0.332877785943627 +-149.82945,58.6768432,13.719616,240969.505544789,971923.761537383,155.293884277344,131,2.1911543528509,0.263481907075674 +-149.76551,58.6747474,13.719616,244673.839528709,971923.775272928,151.965270996094,131,2.18174434887858,0.229302086765693 +-149.70158,58.6726199,13.719616,248378.048954532,971923.797305196,151.134201049805,131,2.17936275452073,0.220651456283261 +-149.63767,58.6704604,13.719616,252081.565742676,971923.755656595,148.462997436523,131,2.17161822461893,0.192521113171037 +-149.57376,58.6682692,13.719616,255785.548559882,971923.75860148,143.083419799805,131,2.15558931156105,0.134299525837526 +-149.50985,58.6660461,13.719616,259490.005660436,971923.784981676,132.864105224609,131,2.12340766710938,0.0174066076332239 +-149.44596,58.6637913,13.719616,263193.788262009,971923.779000752,137.790252685547,131,2.13921849656576,0.0748360530788274 +-149.38207,58.6615046,13.719616,266898.058714847,971923.796567421,139.400634765625,131,2.14426475134148,0.0931654907687495 +-149.3182,58.6591861,13.719616,270601.668976826,971923.768535253,135.187271118164,131,2.13093580149179,0.0447509404536403 +-149.25433,58.6568358,13.719616,274305.779873053,971923.775378203,148.250854492188,131,2.17099720524151,0.190265393535658 +-149.19047,58.6544537,13.719616,278009.821140794,971923.776462542,142.949554443359,131,2.15518280605223,0.132822981801273 +-149.12662,58.6520398,13.719616,281713.7995437,971923.771359662,144.593948364258,131,2.16015011697644,0.15086567288971 +-149.06278,58.6495942,13.719616,285417.721013074,971923.770803006,143.159042358398,131,2.15581878457788,0.135133037332788 +-148.99895,58.6471168,13.719616,289121.593116835,971923.763249369,135.165863037109,131,2.13086702173439,0.0445011127430705 +-148.93512,58.6446076,13.719616,292825.999640495,971923.792412088,135.960494995117,131,2.13341273706178,0.0537478774316182 +-148.87131,58.6420667,13.719616,296529.79241931,971923.781442912,137.062240600586,131,2.13691782709116,0.0664793648706339 +-148.80751,58.639494,13.719616,300233.556075023,971923.76238523,144.827590942383,131,2.16085130669925,0.1534125941024 +-148.74371,58.6368895,13.719616,303937.874386188,971923.780674456,167.173156738281,131,2.22316654334012,0.37975932012139 +-148.67993,58.6342533,13.719616,307641.5991489,971923.756162223,181.619155883789,131,2.25916165286282,0.510503831934961 +-148.61615,58.6315854,13.719616,311345.891133401,971923.780637726,203.857604980469,230,2.30932691760052,0.692718392054359 +-148.55239,58.6288858,13.719616,315049.60299323,971923.760610896,229.056564331055,230,2.35994274235486,0.876569514756864 +-148.48863,58.6261544,13.719616,318753.896420198,971923.778996374,249.633224487305,330,2.39730238650415,1.01227040581115 +-148.42489,58.6233914,13.719616,322457.622220705,971923.762382186,305.07666015625,330,2.48440898327964,1.32866642799775 +-148.36115,58.6205966,13.719616,326161.943018708,971923.784809283,459.241455078125,330,2.66204108430949,1.97387692018752 +-148.29743,58.6177702,13.719616,329865.709572805,971923.770663398,696.882690429688,430,2.84315967739946,2.63175134668358 +-136.56332,57.5273641,12.57266652,1029921.99246539,971923.833661582,650.971435546875,450,2.81356193226014,2.52424388830004 +-136.50347,57.5187402,13.719616,1033625.8740639,971923.792520978,200.709747314453,250,2.30256846417701,0.668169760165522 +-136.44365,57.5100875,13.719616,1037329.69919672,971923.750369077,182.199295043945,150,2.26054669229056,0.515534690466134 +-136.38385,57.5014059,13.719616,1041034.05274994,971923.85203372,159.645233154297,150,2.2031559554737,0.307075153400127 +-136.32409,57.4926953,13.719616,1044737.78855664,971923.772653158,148.51481628418,150,2.17176978233661,0.193071614060519 +-136.26435,57.4839559,13.719616,1048442.05975664,971923.846722255,121.898788452148,150,2.08599938920196,-0.118470935112033 +-136.20465,57.4751877,13.719616,1052145.71720489,971923.757933357,86.4556884765625,50,1.93679357358109,-0.660429045026786 +-136.14497,57.4663906,13.719616,1055849.92283056,971923.810710335,67.5639495849609,50,1.82971502918817,-1.04936888152126 +-136.08533,57.4575647,13.719616,1059553.52452977,971923.69730499,53.6682891845703,50,1.7297177512486,-1.41258753706251 +-136.02571,57.4487101,13.719616,1063257.67826827,971923.745916231,40.2432479858398,50,1.60469302486603,-1.86671302889369 +-135.96612,57.4398267,13.719616,1066961.81487134,971923.785709791,45.091438293457,50,1.65409408833273,-1.68727426591532 +-135.90656,57.4309145,10.13045028,1070665.93922072,971923.815613194,53.0256805419922,50,1.72448625104499,-1.43158983902082 +-153.41922,58.7101097,11.33130043,33545.9126673256,968219.778344779,23.3863410949707,20,1.36896227967302,-2.7229543796881 +-153.3551,58.7098039,13.719616,37249.7117493997,968219.777297754,30.5166778564453,20,1.48453725316409,-2.30315308758683 +-153.29098,58.7094661,13.719616,40953.5802885986,968219.776194593,61.4317970275879,20,1.78839321966191,-1.19946148813931 +-153.22686,58.7090963,13.719616,44657.5251906157,968219.775213568,145.186614990234,132,2.16192657983632,0.157318293049754 +-153.16274,58.7086945,13.719616,48361.553360811,968219.774549829,169.628112792969,132,2.22949783034447,0.402756361650399 +-153.09862,58.7082607,13.719616,52065.6717041872,968219.774415427,155.049331665039,132,2.19046989856553,0.260995773748537 +-153.0345,58.7077949,13.719616,55769.8871253504,968219.77503928,135.04638671875,132,2.13048296875967,0.0431061227192352 +-152.97039,58.7072972,13.719616,59473.628768903,968219.778887371,156.608963012695,132,2.19481661388772,0.276784284474772 +-152.90627,58.7067674,13.719616,63178.0590469565,968219.781224054,143.308883666992,132,2.15627311299308,0.136783287815031 +-152.84216,58.7062056,13.719616,66882.029527664,968219.775036076,156.101379394531,132,2.19340674073562,0.271663222768491 +-152.77806,58.7056119,13.719616,70585.5469081218,968219.770121674,164.364562988281,132,2.21580818937448,0.353031678234853 +-152.71395,58.7049862,13.719616,74289.7734472087,968219.776318153,192.258010864258,132,2.28388444471097,0.600304068514772 +-152.64985,58.7043285,13.719616,77993.5608739424,968219.772140638,202.69938659668,132,2.30685243444496,0.683730362945554 +-152.58574,58.7036388,13.719616,81698.0712619571,968219.780866547,131.154724121094,132,2.1177839382567,-0.00302038073171617 +-152.52165,58.7029171,13.719616,85401.5787527319,968219.765954172,135.008666992188,132,2.13036164928065,0.0426654557434055 +-152.45755,58.7021635,13.71179345,89105.822745348,968219.775863589,78.1425552368164,30,1.89288760841302,-0.819908042527328 +-152.39346,58.7013779,13.719616,92809.6552042343,968219.773541026,154.969985961914,132,2.19024759369727,0.260188299014872 +-152.32937,58.7005603,13.719616,96513.6606140203,968219.772260361,116.975341796875,132,2.06809432285571,-0.183507246696367 +-152.26528,58.6997107,13.719616,100217.845872279,968219.772452779,118.380821228027,30,2.07328134842147,-0.164666489317032 +-152.2012,58.6988292,13.719616,103921.639986786,968219.770090811,125.067749023438,132,2.09714533345916,-0.0779856842006827 +-152.13712,58.6979157,13.719616,107625.62772097,968219.768998693,129.162307739258,132,2.11113579594153,-0.0271683311891526 +-152.07304,58.6969703,13.719616,111329.815645709,968219.780830245,129.140014648438,132,2.11106083133213,-0.0274406240475072 +-152.00897,58.6959928,13.719616,115033.633706699,968219.766417773,139.424743652344,132,2.14433985466638,0.0934382874814095 +-151.9449,58.6949835,13.719616,118737.665378509,968219.775998071,125.39966583252,132,2.09829637917982,-0.0738047576020966 +-151.88083,58.6939421,13.719616,122441.918558684,968219.77658769,111.824478149414,132,2.04853688013011,-0.254545460925669 +-151.81677,58.6928688,13.719616,126145.821849994,968219.772083449,133.447296142578,132,2.12530977870611,0.0243156198692567 +-151.75271,58.6917636,13.719616,129849.959696905,968219.780929158,149.124526977539,132,2.17354907910006,0.199534527767209 +-151.68866,58.6906264,13.719616,133553.761759175,968219.772425904,150.231796264648,132,2.17676185997082,0.211204264908783 +-151.62461,58.6894573,13.719616,137257.812111846,968219.777337275,176.358123779297,132,2.24639546985131,0.464133411405747 +-151.56057,58.6882562,13.719616,140961.540434093,968219.763883168,175.962036132812,132,2.24541897874316,0.46058651698262 +-151.49653,58.6870232,13.719616,144665.530777234,968219.763975365,176.864761352539,132,2.24764131242004,0.468658667214241 +-151.43249,58.6857583,13.719616,148369.789994056,968219.778262135,179.662445068359,132,2.25445730580071,0.493416300651052 +-151.36846,58.6844614,13.719616,152073.74779264,968219.773341599,179.678558349609,132,2.25449625437085,0.493557772974809 +-151.30443,58.6831326,13.719616,155777.988188496,968219.782847737,182.11003112793,132,2.26033386860394,0.514761654090371 +-151.24041,58.6817719,13.719616,159481.940444523,968219.783464608,186.734497070312,132,2.27122455631719,0.554319740376668 +-151.1764,58.6803792,13.719616,163185.61188374,968219.763067445,186.052490234375,132,2.26963548724554,0.548547787942959 +-151.11239,58.6789547,13.719616,166889.585999773,968219.768178434,173.511779785156,132,2.23932896455644,0.438465847193377 +-151.04838,58.6774982,13.719616,170593.870598864,968219.777213218,152.559417724609,132,2.18343902246407,0.23545762493617 +-150.98438,58.6760098,13.719616,174297.89446367,968219.775858326,180.269012451172,131,2.2559210795895,0.498733144854547 +-150.92039,58.6744896,13.719616,178001.663918742,968219.774387063,195.538833618164,230,2.29123302030616,0.62699619256879 +-150.8564,58.6729374,13.719616,181705.764417082,968219.776955549,191.353271484375,230,2.28183589156949,0.592863138789627 +-150.79242,58.6713533,13.719616,185409.62470487,968219.767625629,199.610122680664,230,2.30018256156499,0.659503480874248 +-150.72844,58.6697373,13.719616,189113.829206774,968219.774032089,206.018493652344,230,2.3139062074112,0.709351679706212 +-150.66447,58.6680895,13.719616,192817.806612251,968219.779151937,209.567657470703,230,2.32132425891369,0.736296160085939 +-150.60051,58.6664097,13.719616,196521.564868147,968219.759851261,213.554779052734,230,2.32950929476545,0.766026546541372 +-150.53655,58.6646981,13.719616,200225.687261605,968219.767812536,208.344085693359,230,2.31878117656102,0.727058959113073 +-150.4726,58.6629546,13.719616,203929.603599675,968219.762064205,194.905654907227,230,2.28982443973012,0.621879825867711 +-150.40865,58.6611793,13.719616,207633.897695198,968219.784273101,171.63134765625,131,2.23459661259647,0.421276594127024 +-150.34471,58.6593721,13.719616,211337.999373491,968219.792386477,151.966262817383,131,2.18174718334928,0.229312382372294 +-150.28078,58.657533,13.719616,215041.9154619,968219.785679083,134.20263671875,131,2.12776104862846,0.0332193318893265 +-150.21686,58.655662,13.719616,218745.652786079,968219.763442244,120.002059936523,131,2.07918870114251,-0.143209298107867 +-150.15294,58.6537593,13.719616,222449.794462116,968219.78079539,119.964027404785,131,2.07905103736687,-0.143709332234162 +-150.08903,58.6518246,13.719616,226153.771634893,968219.77120717,148.9560546875,131,2.17305816088392,0.197751372684182 +-150.02513,58.6498582,13.719616,229857.589151388,968219.76749005,139.889343261719,131,2.14578463129731,0.0986861285852762 +-149.96123,58.6478599,13.719616,233561.832710653,968219.78185494,139.93049621582,131,2.14591237421249,0.0991501273146455 +-149.89734,58.6458297,13.719616,237265.931543148,968219.779622188,146.944152832031,131,2.16715230940621,0.176299634419302 +-149.83346,58.6437678,13.719616,240969.891062288,968219.78249128,140.164947509766,131,2.14663941872033,0.101790960486272 +-149.76959,58.641674,13.719616,244673.719439637,968219.767557439,139.857406616211,131,2.14568547083178,0.0983259494712411 +-149.70572,58.6395485,13.719616,248377.999628198,968219.793950383,137.01969909668,131,2.13678300944818,0.0659896687105439 +-149.64187,58.6373911,13.719616,252081.584665971,968219.764558562,136.857498168945,131,2.13626859658859,0.0641211743764747 +-149.57802,58.6352019,13.719616,255785.635789082,968219.765347853,129.633163452148,131,2.11271611929556,-0.0214281456981359 +-149.51418,58.6329809,13.719616,259489.5821842,968219.758388813,126.71900177002,131,2.10284174310053,-0.0572946984660204 +-149.45034,58.6307282,13.719616,263194.007443508,968219.793949619,126.807731628418,131,2.10314573383902,-0.0561905173362454 +-149.38652,58.6284436,13.719616,266897.764682702,968219.770528245,125.787117004395,131,2.09963616336354,-0.0689382790343233 +-149.3227,58.6261273,13.719616,270602.01430034,968219.789763827,102.700157165527,131,2.01157110821334,-0.388815695609141 +-149.2589,58.6237792,13.719616,274305.608653558,968219.759107002,130.325942993164,131,2.11503087601414,-0.0130202885988872 +-149.1951,58.6213994,13.719616,278009.708869596,968219.771308055,126.182800292969,131,2.1010001611924,-0.0639838495961598 +-149.13131,58.6189878,13.719616,281713.744909003,968219.774040581,125.731086730957,131,2.09944266930534,-0.0696411046824084 +-149.06753,58.6165444,13.719616,285417.723529944,968219.766889663,115.967529296875,131,2.06433640456095,-0.197157078559615 +-149.00376,58.6140693,13.719616,289121.650648324,968219.760601368,111.974403381348,131,2.04911875712808,-0.252431917584811 +-148.94,58.6115625,13.719616,292825.532985708,968219.754790935,120.195526123047,131,2.07988830280621,-0.140668145179131 +-148.87624,58.609024,13.719616,296529.954847698,968219.793740445,120.350463867188,131,2.08044776851692,-0.138636006030417 +-148.8125,58.6064537,13.719616,300233.768650774,968219.777211874,123.96443939209,131,2.0932971207212,-0.0919634912542057 +-148.74877,58.6038517,13.719616,303937.557845166,968219.760105893,127.138046264648,131,2.10427553332535,-0.0520867631250107 +-148.68504,58.601218,13.719616,307641.906729464,968219.788426482,139.81982421875,131,2.14556875179903,0.0979019926293756 +-148.62133,58.5985526,13.719616,311345.666840943,968219.769779917,166.407974243164,131,2.22117413377457,0.372522319888988 +-148.55762,58.5958555,13.719616,315050.000059688,968219.797084182,187.231643676758,134,2.27237924991932,0.558513917121952 +-148.49393,58.5931267,13.719616,318753.757918106,968219.775746908,212.953109741211,330,2.32828398643178,0.761575876935644 +-148.43025,58.5903662,13.719616,322457.52470505,968219.752394512,294.694915771484,330,2.46937264324241,1.27405014918378 +-148.36657,58.5875741,13.719616,326161.883759973,968219.787036339,519.66650390625,430,2.71572472444744,2.16887122400498 +-136.5196,57.4867128,13.62228548,1033625.6020384,968219.72687848,498.966491699219,450,2.69807138137739,2.10474924320878 +-136.45982,57.4780676,13.719616,1037330.00056591,968219.836270009,195.124053955078,150,2.29031081043006,0.623646463073909 +-136.40008,57.4693935,13.719616,1041033.76903517,968219.773626527,177.259735107422,150,2.24861009596982,0.472177565585406 +-136.34036,57.4606905,13.719616,1044738.06757146,968219.850760985,162.017639160156,150,2.2095622995605,0.330344823676044 +-136.28068,57.4519587,13.719616,1048441.74300481,968219.76324278,137.530136108398,150,2.13839787279566,0.0718553133164773 +-136.22102,57.4431981,13.719616,1052145.95541943,968219.825127784,101.374092102051,150,2.00592697773132,-0.409316788515047 +-136.1614,57.4344086,13.719616,1055849.55751157,968219.70823025,91.2675628662109,50,1.96031645364302,-0.574987230543438 +-136.1018,57.4255904,13.719616,1059553.70343649,968219.750390253,77.8821029663086,50,1.89143766979115,-0.825174633455655 +-136.04223,57.4167434,13.719616,1063257.82345499,968219.781310797,65.6630554199219,50,1.81732108736589,-1.09438721580297 +-135.98269,57.4078677,13.719616,1066961.91946234,968219.81065909,74.1092758178711,50,1.86987256944219,-0.903505233215508 +-135.92318,57.3989633,12.98777048,1070665.99631102,968219.837346927,52.8831787109375,50,1.72331755190741,-1.43583488786846 +-135.8637,57.3900301,11.51050546,1074370.06185882,968219.849544441,50.6667251586914,50,1.70472283459515,-1.5033762086073 +-135.80426,57.3810683,9.776241689,1078073.53734666,968219.705355149,124.182609558105,50,2.09406078181676,-0.0891896561845715 +-153.48385,58.6772446,13.53216527,29841.5057229851,964515.776788909,19.5152778625488,20,1.29037473923564,-3.0084067576739 +-153.41978,58.676971,13.719616,33545.9273189271,964515.774773745,30.7109870910645,20,1.48729377545684,-2.29314061182975 +-153.35572,58.6766655,13.719616,37249.833138239,964515.776054799,52.3564300537109,20,1.71897002632733,-1.45162634168264 +-153.29166,58.676328,13.719616,40953.8083142795,964515.774110191,103.696189880371,132,2.01576279935597,-0.373590276951326 +-153.2276,58.6759586,13.719616,44657.8596192063,964515.780293808,156.368850708008,132,2.19415024416533,0.274363839442197 +-153.16354,58.6755572,13.719616,48361.9940632579,964515.783624166,166.307083129883,132,2.22091074650583,0.371565622150733 +-153.09949,58.6751238,13.719616,52065.6404038489,964515.77647292,156.992858886719,132,2.1958798981632,0.28064643645489 +-153.03543,58.6746584,13.719616,55769.9618301289,964515.774190612,149.720809936523,132,2.17528216782798,0.205829600699803 +-152.97138,58.6741611,13.719616,59473.8087815409,964515.771960291,150.050338745117,132,2.17623698020052,0.209297751767448 +-152.90733,58.6736319,13.719616,63177.7662699889,964515.777883505,138.901947021484,132,2.14270833338888,0.0875121365189943 +-152.84328,58.6730707,13.719616,66881.8413575097,964515.781063612,159.699325561523,132,2.20330308204,0.30760955908305 +-152.77923,58.6724775,13.719616,70586.0409433024,964515.781796362,177.952987670898,132,2.25030528381552,0.478334971695762 +-152.71519,58.6718524,13.719616,74289.7935657706,964515.78038258,200.647125244141,132,2.3024329417945,0.66767750419031 +-152.65115,58.6711953,13.719616,77993.6844617064,964515.776047541,129.190475463867,132,2.11123049658506,-0.0268243514215819 +-152.58711,58.6705062,13.719616,81697.7205286017,964515.769137476,60.2759857177734,30,1.78014432130232,-1.22942384145133 +-152.52307,58.6697853,13.68293969,85401.9081662338,964515.782363269,13.0298166275024,30,1.11493830379975,-3.64564196572106 +-152.45904,58.6690323,13.719616,89105.6768400514,964515.769164985,56.5912628173828,30,1.75274938519707,-1.32893006867885 +-152.39501,58.6682475,13.719616,92809.6108116721,964515.775762106,122.902526855469,132,2.08956081200041,-0.105534830976802 +-152.33098,58.6674306,13.719616,96513.7177538278,964515.769047079,135.696411132812,30,2.13256836169196,0.0506808650797362 +-152.26695,58.6665819,13.719616,100218.003717984,964515.782969576,129.461486816406,30,2.11214059041907,-0.02351863084982 +-152.20293,58.6657012,13.719616,103921.897993533,964515.779981521,128.560150146484,132,2.10910637097178,-0.034539781934858 +-152.13891,58.6647886,13.719616,107625.985303802,964515.786251823,129.334686279297,132,2.11171501397166,-0.0250644459784511 +-152.0749,58.663844,13.719616,111329.694687995,964515.774324461,121.97679901123,132,2.08627723215334,-0.117461730208351 +-152.01089,58.6628675,13.719616,115033.610846198,964515.771516733,118.435401916504,132,2.07348153818828,-0.163939342944145 +-151.94688,58.6618591,13.719616,118737.740635953,964515.778341834,131.691833496094,132,2.11955884422869,0.00342658436713379 +-151.88288,58.6608187,13.719616,122441.513126079,964515.765721792,127.123077392578,132,2.10422439771756,-0.052272502248064 +-151.81888,58.6597464,13.719616,126145.51298158,964515.762696365,123.005996704102,132,2.08992628438263,-0.104207330968383 +-151.75488,58.6586422,13.719616,129849.747057142,964515.769828936,133.151840209961,132,2.12434717293425,0.0208191609508112 +-151.69089,58.6575061,13.719616,133553.644062387,964515.76758945,139.664505004883,132,2.1450860464921,0.096148669176786 +-151.6269,58.6563381,13.719616,137257.788993984,964515.775569393,144.779876708984,132,2.16070820245799,0.152892798652128 +-151.56292,58.6551382,13.719616,140961.610559449,964515.773156624,155.538803100586,132,2.19183875265684,0.265967842518014 +-151.49894,58.6539063,13.719616,144665.694174091,964515.769922865,173.92822265625,132,2.2403700589974,0.442247399360879 +-151.43496,58.6526426,13.719616,148370.045856365,964515.788852726,171.492858886719,132,2.2342460403516,0.420003215670367 +-151.371,58.6513469,13.719616,152073.517018725,964515.762475177,183.791488647461,132,2.26432539541228,0.529260018753442 +-151.30703,58.6500194,13.719616,155777.848066378,964515.780829871,173.591903686523,132,2.23952946585048,0.439194125122083 +-151.24307,58.6486599,13.719616,159481.890452394,964515.775923154,187.580474853516,132,2.2731876309264,0.561450187674587 +-151.17912,58.6472686,13.719616,163185.650104349,964515.769129643,184.248458862305,132,2.26540386391021,0.533177324163508 +-151.11517,58.6458454,13.719616,166889.712462601,964515.773468822,184.28239440918,132,2.26548384647156,0.533467843655613 +-151.05123,58.6443903,13.719616,170593.506225017,964515.764000029,165.881271362305,132,2.21979735526395,0.3675214673667 +-150.98729,58.6429033,13.719616,174297.616376219,964515.766058858,171.380676269531,131,2.23396185222768,0.418970963288932 +-150.92335,58.6413845,13.719616,178002.049237824,964515.791589998,199.24333190918,230,2.29938379574691,0.656602135432543 +-150.85943,58.6398337,13.719616,181705.656383993,964515.76433917,195.96516418457,230,2.29217887570831,0.630431809363422 +-150.79551,58.6382512,13.719616,185409.599354194,964515.771102304,204.568832397461,230,2.31083946638057,0.698212400947915 +-150.73159,58.6366367,13.719616,189113.886568373,964515.779217475,202.28466796875,230,2.30596296695813,0.680499563154098 +-150.66768,58.6349904,13.719616,192817.945627032,964515.782823645,205.841644287109,230,2.31353324241122,0.707996964371466 +-150.60378,58.6333122,13.719616,196521.78390119,964515.769947322,214.741333007812,230,2.33191564466701,0.774767096224465 +-150.53988,58.6316022,13.719616,200225.985783244,964515.781105781,209.540542602539,230,2.32126806417622,0.736092044759869 +-150.47599,58.6298604,13.719616,203929.97992576,964515.786486416,201.860809326172,131,2.30505201014969,0.677190708012893 +-150.41211,58.6280867,13.719616,207633.773727273,964515.774167078,187.492599487305,131,2.27298413038237,0.560711015613845 +-150.34823,58.6262812,13.719616,211337.951543175,964515.786386155,173.60774230957,131,2.23956908931597,0.439338048858391 +-150.28436,58.6244438,13.719616,215041.942646143,964515.780548497,151.552276611328,131,2.18056246470437,0.225009146101641 +-150.2205,58.6225747,13.719616,218745.752587004,964515.778259903,124.79801940918,131,2.09620769298671,-0.0813914620258411 +-150.15664,58.6206737,13.719616,222449.967558839,964515.790003094,121.774963378906,131,2.08555800763949,-0.120074158929799 +-150.09279,58.6187409,13.719616,226154.015579233,964515.793876908,136.631973266602,131,2.13555234054915,0.0615195280013802 +-150.02895,58.6167762,13.719616,229857.904100912,964515.778061908,128.578079223633,131,2.10916693372281,-0.0343198007367589 +-149.96512,58.6147798,13.719616,233561.638581859,964515.76422472,132.32649230957,131,2.12164680043891,0.0110106372847118 +-149.90129,58.6127516,13.719616,237265.804604507,964515.776304969,147.891052246094,131,2.16994189896174,0.186432219913123 +-149.83747,58.6106916,13.719616,240969.830804165,964515.779077499,136.276473999023,131,2.1344208881584,0.0574097699695384 +-149.77366,58.6085998,13.719616,244673.723958311,964515.771944901,132.969467163086,131,2.12375192844904,0.0186570630808569 +-149.70985,58.6064762,13.719616,248378.068986557,964515.791726304,127.293762207031,131,2.10480712238547,-0.0501558799280413 +-149.64606,58.6043209,13.719616,252081.71564224,964515.774766883,124.455848693848,131,2.09501531071383,-0.0857225347807227 +-149.58227,58.6021337,13.719616,255785.828438778,964515.773571254,115.208145141602,131,2.06148318451257,-0.207520788165405 +-149.51849,58.5999149,13.719616,259489.833773072,964515.783661939,131.264068603516,131,2.11814586133087,-0.00170577282322229 +-149.45472,58.5976642,13.719616,263193.740641464,964515.771069043,130.257919311523,131,2.11480413664521,-0.0138438707047054 +-149.39096,58.5953818,13.719616,266897.554291598,964515.757594191,131.646865844727,131,2.11941052418996,0.00288784365171099 +-149.3272,58.5930677,13.719616,270601.859598899,964515.783498825,127.486480712891,131,2.10546413251042,-0.047769431624861 +-149.26346,58.5907218,13.719616,274305.507800975,964515.756231244,122.788696289062,131,2.08915838826084,-0.106996548862111 +-149.19972,58.5883442,13.719616,278009.661138037,964515.768538915,115.176734924316,131,2.06136476281647,-0.207950929566567 +-149.13599,58.5859348,13.719616,281713.749008835,964515.768093027,109.736808776855,131,2.04035232645643,-0.284274095972647 +-149.07227,58.5834938,13.719616,285417.776511222,964515.776766644,113.342720031738,131,2.05439363075651,-0.233272070967524 +-149.00856,58.581021,13.719616,289121.752012091,964515.771864619,118.338050842285,131,2.07312441169263,-0.165236528310384 +-148.94486,58.5785165,13.719616,292825.68141195,964515.764145571,116.30583190918,131,2.06560149204981,-0.192561919708142 +-148.88117,58.5759803,13.719616,296529.571426848,964515.75323822,115.453826904297,131,2.06240833288657,-0.204160385207383 +-148.81748,58.5734125,13.719616,300234.006043322,964515.795137842,121.941207885742,131,2.0861504926009,-0.117922084437909 +-148.75381,58.5708129,13.719616,303937.837416526,964515.777361677,126.000442504883,131,2.10037207033257,-0.0662652548740411 +-148.69015,58.5681817,13.719616,307641.648646375,964515.766520707,127.152671813965,131,2.10432549028342,-0.0519053051941752 +-148.62649,58.5655188,13.719616,311346.025454844,964515.798048001,133.051300048828,131,2.12401912241446,0.0196275878279941 +-148.56285,58.5628242,13.719616,315049.818258105,964515.778447565,149.554946899414,134,2.17480078296804,0.204081073487595 +-148.49922,58.560098,13.719616,318753.610977379,964515.764906569,161.462478637695,330,2.20807161512629,0.324930232327279 +-148.43559,58.5573401,13.719616,322457.989359355,964515.794582261,322.153228759766,430,2.50806248839235,1.41458270994964 +-148.37198,58.5545506,13.719616,326161.802866822,964515.781816291,657.806030273438,430,2.8180978504517,2.54071963785174 +-136.47597,57.4460446,13.719616,1037329.77817502,964515.777239314,360.027770996094,351,2.55633600167059,1.58992588880867 +-136.41628,57.437378,13.719616,1041033.53376623,964515.70699695,267.207733154297,250,2.4268490227318,1.11959222203959 +-136.35661,57.4286826,13.719616,1044737.81318793,964515.783842235,177.589981079102,150,2.24941846096513,0.475113777978694 +-136.29697,57.4199583,13.719616,1048442.04615445,964515.839658774,165.89680480957,150,2.21983802154615,0.367669178910977 +-136.23737,57.4112053,13.719616,1052145.65356007,964515.73642534,146.738876342773,150,2.16654518912882,0.174094400282467 +-136.17779,57.4024235,13.719616,1055849.7995296,964515.778542041,125.008018493652,150,2.09693787121491,-0.0787392462873995 +-136.11824,57.3936129,13.719616,1059553.91081809,964515.807020304,104.007270812988,150,2.01706370048711,-0.368865032728892 +-136.05872,57.3847736,13.719616,1063257.98933883,964515.831513276,85.5801239013672,50,1.93237291091212,-0.676486153623205 +-135.99923,57.3759055,13.719616,1066962.04293932,964515.840158087,57.0863914489746,50,1.75653259120551,-1.3151883846217 +-135.93977,57.3670088,13.719616,1070666.07050255,964515.853376697,50.3873710632324,50,1.70232169984187,-1.51209781538334 +-135.88035,57.3580834,13.719616,1074369.50171027,964515.697547366,213.644317626953,150,2.32969134622377,0.766687809400622 +-135.82094,57.3491293,11.48346687,1078074.07583459,964515.856921241,203.695266723633,50,2.30898093739638,0.691461693200352 +-135.70223,57.3311352,8.542280208,1085482.04093557,964515.844303954,29.9077892303467,50,1.4757843113748,-2.33494627050383 +-153.54834,58.6443463,13.719616,26138.0477224365,960811.777539299,23.4887733459473,20,1.37086033721199,-2.71606009294702 +-153.48434,58.6441049,13.719616,29841.9359122628,960811.772007656,33.1374397277832,20,1.52031895082293,-2.17318374857661 +-153.42034,58.6438317,13.719616,33545.8794084407,960811.782123136,54.7579879760742,20,1.7384474820671,-1.38087866301644 +-153.35634,58.6435264,13.719616,37249.8853704816,960811.774501175,96.3728256225586,20,1.98395459255549,-0.489126763016782 +-153.29234,58.6431893,13.719616,40953.9603723103,960811.782830371,132.656097412109,132,2.12272721671242,0.0149350175716076 +-153.22835,58.6428202,13.719616,44657.5328058463,960811.778211629,163.058364868164,132,2.21234308295125,0.340445422665854 +-153.16435,58.6424191,13.719616,48361.7669729178,960811.773730434,168.366134643555,132,2.22625474146008,0.390976537152575 +-153.10036,58.6419861,13.719616,52065.5122164668,960811.766766769,167.805252075195,132,2.22480554952951,0.385712658420201 +-153.03636,58.6415212,13.719616,55769.9328052645,960811.772670251,156.641311645508,132,2.19490631106543,0.277110090226354 +-152.97237,58.6410244,13.719616,59473.878200535,960811.775447573,150.868011474609,132,2.17859716613236,0.217870620736028 +-152.90838,58.6404957,13.719616,63177.9339684051,960811.783199692,155.855072021484,132,2.19272094017141,0.269172199372318 +-152.8444,58.639935,13.719616,66881.5284654224,960811.774958739,173.718063354492,132,2.23984497911095,0.440340159340561 +-152.78041,58.6393424,13.719616,70585.8257855774,960811.781778432,190.621017456055,132,2.28017078330108,0.586814990289554 +-152.71643,58.6387178,13.719616,74289.67560412,960811.772096236,205.696472167969,132,2.31322684331785,0.706884035409344 +-152.65245,58.6380614,13.719616,77993.6630638514,960811.778660056,47.4565200805664,30,1.67629588884935,-1.60663098941417 +-152.58847,58.637373,13.68503021,81697.7954691911,960811.779466194,33.8566551208496,30,1.52964404962899,-2.13931232806482 +-152.5245,58.6366527,12.87959053,85401.5007633865,960811.773191034,20.467887878418,30,1.31107302927342,-2.93322466037655 +-152.39655,58.6351163,11.21284953,92809.9725360914,960811.778960974,39.5406913757324,30,1.59704425875713,-1.89449553057643 +-152.33259,58.6343003,11.35537889,96513.5950706345,960811.775036258,12.0008840560913,30,1.07921323992597,-3.77540559465906 +-152.26862,58.6334523,13.719616,100217.975626198,960811.780190438,35.4463348388672,30,1.54957133566728,-2.06693073736005 +-152.20466,58.6325724,13.719616,103921.963386846,960811.776418634,152.731597900391,30,2.18392889543337,0.237236983384355 +-152.14071,58.6316607,13.719616,107625.564896361,960811.773681638,131.044006347656,132,2.11741716210317,-0.00435261640966257 +-152.07675,58.630717,13.719616,111329.945029089,960811.781968038,118.235137939453,132,2.07274656237787,-0.166608984870524 +-152.0128,58.6297414,13.719616,115033.952934309,960811.779975832,114.130226135254,132,2.05740067776896,-0.222349617921633 +-151.94886,58.6287339,13.719616,118737.595466078,960811.766543902,119.513160705566,132,2.07741573212176,-0.149649227646982 +-151.88491,58.6276946,13.719616,122442.036525209,960811.788572467,148.527969360352,132,2.17180824351918,0.193211316053537 +-151.82098,58.6266233,13.719616,126145.547559554,960811.768954405,139.43669128418,132,2.14437706878014,0.0935734597645478 +-151.75704,58.6255201,13.719616,129849.871180533,960811.774733796,147.380294799805,132,2.16843942089216,0.18097479071449 +-151.69311,58.6243851,13.719616,133553.856446617,960811.779112026,149.064468383789,132,2.17337413558024,0.19889908296939 +-151.62919,58.6232182,13.719616,137257.510573599,960811.769841057,148.59033203125,132,2.17199055315221,0.193873516677027 +-151.56526,58.6220194,13.719616,140961.997813127,960811.788311153,132.254928588867,132,2.12141186535044,0.0101572859862221 +-151.50135,58.6207887,13.719616,144665.588906834,960811.771474248,150.117813110352,132,2.17643222906222,0.210006951362731 +-151.43743,58.6195261,13.719616,148370.026805919,960811.783652817,163.87565612793,132,2.2145144435367,0.348332424080214 +-151.37353,58.6182317,13.719616,152073.581807832,960811.769653231,162.695129394531,132,2.21137455165388,0.33692744054744 +-151.30962,58.6169054,13.719616,155777.997281826,960811.786009276,166.478134155273,132,2.22135719976838,0.373187267830771 +-151.24573,58.6155472,13.719616,159481.543964842,960811.76304659,178.587539672852,132,2.25185115421601,0.483950014225697 +-151.18183,58.6141572,13.719616,163185.964329149,960811.783013287,180.681274414062,132,2.25691314514507,0.502336610116104 +-151.11795,58.6127353,13.719616,166889.529561799,960811.761754678,180.62467956543,132,2.25677708964753,0.501842417714934 +-151.05406,58.6112816,13.719616,170593.982111,960811.78489759,186.368606567383,132,2.27037275811024,0.55122576616161 +-150.99019,58.609796,13.719616,174297.593182655,960811.764975047,177.76936340332,132,2.2498569172004,0.476706376173092 +-150.92632,58.6082786,13.719616,178001.526499014,960811.76418946,185.184188842773,230,2.26760390355828,0.541168496119128 +-150.86245,58.6067293,13.719616,181705.789390059,960811.772170632,187.499145507812,230,2.2729992928526,0.560766090033526 +-150.79859,58.6051482,13.719616,185409.809448403,960811.77297499,192.890167236328,230,2.28531008962499,0.605482417762069 +-150.73474,58.6035353,13.719616,189113.59347334,960811.765755987,193.2109375,230,2.28603170780123,0.608103540948514 +-150.67089,58.6018905,13.719616,192817.727524496,960811.767555407,198.17610168457,131,2.29705128116694,0.648129776712126 +-150.60705,58.600214,13.719616,196521.638587112,960811.77196609,201.377593994141,131,2.30401114771696,0.673409998565504 +-150.54321,58.5985056,13.719616,200225.913288509,960811.786016755,199.536499023438,131,2.3000223480159,0.658921539534483 +-150.47938,58.5967654,13.719616,203929.979160114,960811.791055082,193.134674072266,131,2.2858602510264,0.60748076100367 +-150.41556,58.5949933,13.719616,207633.843596481,960811.775157197,184.416168212891,131,2.2657989940377,0.534612549567892 +-150.35175,58.5931895,13.719616,211337.5121925,960811.759895909,166.684051513672,131,2.22189404811261,0.375137254248785 +-150.28794,58.5913539,13.719616,215041.571030517,960811.765760114,139.053314208984,131,2.14318134433661,0.0892302472919245 +-150.22413,58.5894865,13.719616,218746.026897213,960811.793708448,119.062171936035,131,2.07577380070214,-0.155613191216927 +-150.16034,58.5875873,13.719616,222449.729174005,960811.777724182,116.596069335938,131,2.06668390981848,-0.188630269419546 +-150.09655,58.5856563,13.719616,226153.842047697,960811.783559685,141.69807434082,131,2.15136394827965,0.11895180036074 +-150.03277,58.5836935,13.719616,229857.793597985,960811.777611531,127.791358947754,131,2.10650148850013,-0.0440014585793441 +-149.969,58.5816989,13.719616,233561.59060455,960811.759230883,124.979515075684,131,2.09683883525887,-0.079098973147421 +-149.90523,58.5796726,13.719616,237265.817858383,960811.774666948,135.905410766602,131,2.1332367475294,0.053108633217626 +-149.84147,58.5776145,13.719616,240969.904100944,960811.777536203,142.226821899414,131,2.15298150570783,0.124827230636736 +-149.77772,58.5755247,13.719616,244673.855396296,960811.778392396,137.474472045898,131,2.13822206050163,0.0712167128827361 +-149.71398,58.5734031,13.719616,248377.679205322,960811.765497465,124.149627685547,131,2.09394542147935,-0.0896086778571688 +-149.65024,58.5712498,13.719616,252081.960268619,960811.787394276,115.86775970459,131,2.06396260999108,-0.198514807128961 +-149.58652,58.5690647,13.719616,255785.548661015,960811.757020977,118.868438720703,131,2.07506655849617,-0.158182096776029 +-149.5228,58.5668479,13.719616,259489.607799538,960811.761467212,128.020416259766,131,2.10727923497526,-0.0411764613907206 +-149.45909,58.5645994,13.719616,263193.565714615,960811.762255099,127.605262756348,131,2.10586858613208,-0.0463003406284307 +-149.39538,58.5623191,13.719616,266898.008612472,960811.787920481,130.206253051758,131,2.11463184138013,-0.0144696962854536 +-149.33169,58.5600072,13.719616,270601.78427981,960811.780454871,129.91569519043,131,2.11366162161065,-0.0179938114164964 +-149.268,58.5576635,13.719616,274306.058405412,960811.798024928,122.29719543457,131,2.08741649774556,-0.113323592398656 +-149.20433,58.5552881,13.719616,278009.679535324,960811.769273859,109.816299438477,131,2.04066680487575,-0.283131820592628 +-149.14066,58.552881,13.719616,281713.811794824,960811.776929087,109.368644714355,131,2.03889283041275,-0.289575402184946 +-149.077,58.5504422,13.719616,285417.883201657,960811.779263768,115.014694213867,131,2.06075332912166,-0.21017183126667 +-149.01335,58.5479718,13.719616,289121.899634767,960811.787015803,116.85627746582,131,2.067652047456,-0.185113717186092 +-148.94971,58.5454696,13.719616,292825.869475298,960811.777505572,117.170028686523,131,2.06881653624976,-0.180883961508971 +-148.88608,58.5429358,13.719616,296529.797748633,960811.772646799,117.546737670898,131,2.07021058045213,-0.175820395066109 +-148.82246,58.5403704,13.719616,300233.691133253,960811.772079106,118.474411010742,131,2.0736245583048,-0.163419853058937 +-148.75885,58.5377732,13.719616,303937.558067474,960811.753176364,122.019187927246,131,2.08642813031143,-0.116913625027561 +-148.69524,58.5351445,13.719616,307641.981315703,960811.7953596,125.496223449707,131,2.09863065681601,-0.0725905658150887 +-148.63165,58.532484,13.719616,311345.812821037,960811.772806578,126.215545654297,134,2.10111284917187,-0.0635745346903927 +-148.56807,58.529792,13.719616,315049.635279089,960811.764407607,127.867721557617,134,2.10676092666292,-0.0430591051210625 +-148.50449,58.5270683,13.719616,318754.035873733,960811.795602374,169.220916748047,231,2.22845404349504,0.398965029886846 +-148.44093,58.524313,13.719616,322457.862963161,960811.781829711,428.348724365234,430,2.63179747789739,1.86402350931408 +-136.43244,57.4053594,13.69211231,1041033.93014693,960811.810364955,672.265563964844,450,2.82754086558601,2.57501936412439 +-136.37283,57.3966716,13.719616,1044737.60693475,960811.730676786,230.419311523438,250,2.36251887464962,0.885926762552795 +-136.31324,57.3879549,13.719616,1048441.81208831,960811.783237069,176.887176513672,150,2.24769634974853,0.46885857850053 +-136.25368,57.3792094,13.719616,1052145.96889725,960811.820922492,169.206298828125,150,2.22841652593338,0.398828755394341 +-136.19415,57.3704352,13.719616,1055850.07930845,960811.853364868,152.006912231445,150,2.18186333712714,0.229734286047075 +-136.13466,57.3616323,13.719616,1059553.56948989,960811.719886832,130.215667724609,150,2.1146632422734,-0.0143556392783783 +-136.07519,57.3528006,13.719616,1063257.60468591,960811.727137018,110.175491333008,150,2.04208499594382,-0.277980545841356 +-136.01575,57.3439402,13.719616,1066961.60809467,960811.725781629,83.8478240966797,50,1.92349179687572,-0.708744894725751 +-135.95634,57.3350511,13.719616,1070665.58456788,960811.714717679,129.726669311523,150,2.11302926786663,-0.0202907007065044 +-135.89696,57.3261334,13.70509929,1074369.53594538,960811.703604241,62.0530586242676,50,1.79276319294037,-1.18358849787739 +-135.36387,57.2445876,6.443865948,1107705.90277199,960811.811615412,49.9037590026855,50,1.69813326010511,-1.52731142400697 +-153.61272,58.611415,13.59765961,22433.8170307309,957107.781028707,14.3464241027832,20,1.15674366511479,-3.49379296098676 +-153.54878,58.6112057,12.13342117,26137.7503693296,957107.771735756,22.0764694213867,20,1.34392962008024,-2.81388014436148 +-153.48484,58.6109646,13.719616,29841.7320900539,957107.774783075,67.0996322631836,20,1.8267201400422,-1.06024717372589 +-153.4209,58.6106916,13.719616,33545.7691216496,957107.779121166,100.204917907715,132,2.00088903657884,-0.427616028752424 +-153.35696,58.6103866,13.719616,37249.8684356637,957107.773717599,131.024627685547,132,2.11735293430218,-0.00458591011529507 +-153.29302,58.6100498,13.719616,40954.0366894871,957107.781084018,155.964477539062,132,2.19302569472955,0.270279154913112 +-153.22909,58.609681,13.719616,44657.7017135539,957107.772321388,166.686721801758,132,2.22190100547945,0.375162525390957 +-153.16515,58.6092804,13.719616,48362.028640635,957107.782865584,177.325973510742,132,2.24877235278214,0.472766928640446 +-153.10122,58.6088478,13.719616,52065.8660839901,957107.776569352,161.005889892578,132,2.20684176361606,0.320463060607569 +-153.03729,58.6083833,13.719616,55769.8000350936,957107.771559698,154.952529907227,132,2.19019867135154,0.260010599091373 +-152.97336,58.607887,13.719616,59473.8371824556,957107.779255277,154.224395751953,132,2.1881530773624,0.252580417852148 +-152.90943,58.6073587,13.719616,63177.9847216719,957107.777566621,158.621810913086,132,2.20036290371255,0.296929992187308 +-152.84551,58.6067986,13.719616,66881.6698972821,957107.779049657,199.042877197266,132,2.29894664085369,0.655014264083941 +-152.78158,58.6062065,13.719616,70586.0584659702,957107.781233136,191.109786987305,132,2.28128292842468,0.590854618816298 +-152.71766,58.6055825,13.719616,74289.9985844788,957107.774902903,141.887985229492,132,2.15194562188842,0.121064604933955 +-152.65374,58.6049267,13.42980621,77994.0761445226,957107.781631188,37.3047370910645,30,1.57176398360179,-1.98632070564953 +-152.52592,58.6035193,10.51495448,85401.513365282,957107.765240701,12.1198740005493,30,1.08349810488385,-3.75984174210982 +-152.33419,58.6011691,9.55428666,96513.8726385764,957107.772326272,22.2146263122559,30,1.34663901206754,-2.80403885932613 +-152.27029,58.600322,13.71409194,100217.76127683,957107.776373069,22.9879016876221,30,1.36149933111807,-2.75006193897728 +-152.20639,58.5994429,13.719616,103921.835834812,957107.771659884,64.5062942504883,30,1.80960209331567,-1.12242480541362 +-152.1425,58.598532,13.719616,107625.523313288,957107.764786163,137.697296142578,132,2.13892541242913,0.073771487840047 +-152.0786,58.5975892,13.719616,111329.989374679,957107.77691144,141.511703491211,132,2.15079235895194,0.116875624774642 +-152.01472,58.5966146,13.719616,115033.502757822,957107.769410009,144.815521240234,132,2.16081511177643,0.153281123811685 +-151.95083,58.5956081,13.719616,118737.808404409,957107.781912287,132.157318115234,132,2.12109121687421,0.00899259919838747 +-151.88695,58.5945697,13.719616,122441.754645035,957107.779745251,162.577117919922,132,2.21105942034528,0.335782793687193 +-151.82307,58.5934994,13.719616,126145.927587923,957107.780774723,196.546112060547,132,2.29346445732756,0.635101408746064 +-151.7592,58.5923973,13.719616,129849.754444238,957107.777179009,167.553558349609,132,2.22415365541922,0.383344792942509 +-151.69533,58.5912633,13.719616,133553.821675747,957107.776802239,157.948226928711,132,2.1985147550313,0.290216988662838 +-151.63147,58.5900975,13.719616,137257.556470091,957107.770739782,165.737579345703,132,2.21942099153386,0.366154406874135 +-151.56761,58.5888998,13.719616,140961.545308421,957107.767985201,159.504684448242,132,2.20277344225306,0.305685756202629 +-151.50375,58.5876703,13.719616,144665.794614253,957107.780334222,157.369842529297,132,2.19692151024685,0.28442986884838 +-151.4399,58.5864089,13.719616,148369.732368957,957107.774920899,149.993179321289,132,2.17607151071917,0.208696719381512 +-151.37605,58.5851157,13.719616,152073.944231816,957107.784798982,158.737609863281,132,2.20067983677973,0.298081183548994 +-151.31221,58.5837906,13.719616,155777.858203336,957107.776021059,153.626892089844,132,2.18646724475777,0.246456992647598 +-151.24837,58.5824337,13.719616,159482.059918934,957107.782788704,163.925186157227,132,2.21464568553367,0.348809132473423 +-151.18454,58.581045,13.719616,163185.976924469,957107.781239049,174.142654418945,132,2.24090516003112,0.444191039048377 +-151.12072,58.5796245,13.719616,166889.616024055,957107.770424657,177.252883911133,132,2.24859330990025,0.472116593789507 +-151.0569,58.5781721,13.719616,170593.563775151,957107.763937136,182.678863525391,132,2.2616883011275,0.519681339609493 +-150.99308,58.5766879,13.719616,174297.826505589,957107.773701328,181.804397583008,132,2.2596043839626,0.5121119576574 +-150.92927,58.5751719,13.719616,178001.831755973,957107.773689592,174.871917724609,131,2.2427200727351,0.450783320016905 +-150.86547,58.5736241,13.719616,181705.586325057,957107.763020622,170.1142578125,131,2.23074071472836,0.407270872487226 +-150.80167,58.5720445,13.719616,185409.676269692,957107.768748109,166.807693481445,131,2.22221607723389,0.376306955933504 +-150.73788,58.5704331,13.719616,189113.529126253,957107.763220727,165.72053527832,131,2.2193763274023,0.365992173999874 +-150.67409,58.5687899,13.719616,192817.730948681,957107.774640621,172.547103881836,131,2.23690767426968,0.429671029766789 +-150.61031,58.5671149,13.719616,196521.709270372,957107.774274005,169.923675537109,131,2.23025389351755,0.405502598896952 +-150.54653,58.5654081,13.719616,200226.050142239,957107.791471466,170.404602050781,131,2.23148131941115,0.409960960084722 +-150.48277,58.5636695,13.719616,203929.60183507,957107.765709418,167.011795043945,131,2.22274714385183,0.378235941471368 +-150.41901,58.5618991,13.719616,207633.529656147,957107.757078633,149.786422729492,131,2.17547244887148,0.206520755761428 +-150.35525,58.560097,13.719616,211337.839779053,957107.777661911,133.596084594727,131,2.1257937301169,0.0260734695267493 +-150.2915,58.5582631,13.719616,215041.960320867,957107.784858762,118.724433898926,131,2.07454010745887,-0.160094317207611 +-150.22776,58.5563974,13.719616,218745.898064899,957107.777952565,110.625610351562,131,2.0438556798332,-0.271548916551634 +-150.16403,58.5545,13.719616,222449.659147576,957107.767400342,114.087341308594,131,2.05723745945055,-0.222942473441252 +-150.1003,58.5525708,13.719616,226153.830232054,957107.775413469,131.965682983398,131,2.12046100977712,0.00670350714272228 +-150.03658,58.5506099,13.719616,229857.838170346,957107.779542315,123.957855224609,131,2.0932740532709,-0.0920472788178225 +-149.97287,58.5486172,13.719616,233561.690383943,957107.767978667,125.012809753418,131,2.09695451636958,-0.0786787863346551 +-149.90916,58.5465928,13.719616,237265.972218897,957107.786969316,136.668640136719,131,2.13566887317787,0.061942807770636 +-149.84547,58.5445367,13.719616,240969.531896729,957107.764998015,148.677093505859,131,2.17224406246737,0.194794334868474 +-149.78178,58.5424488,13.719616,244673.535384551,957107.762318993,141.463470458984,131,2.15064430822613,0.116337862280627 +-149.71809,58.5403292,13.719616,248377.988731177,957107.791172422,131.012649536133,131,2.11731322969029,-0.00473012859853576 +-149.65442,58.5381779,13.719616,252081.740152439,957107.776744524,123.912940979004,131,2.09311666474803,-0.0926189588560499 +-149.59075,58.5359948,13.719616,255785.955641739,957107.782687036,137.696136474609,131,2.13892175484445,0.0737582024485202 +-149.52709,58.5337801,13.719616,259490.061198294,957107.793363958,125.776817321777,131,2.09960060106929,-0.0690674514375554 +-149.46344,58.5315337,13.719616,263194.06428178,957107.797100926,127.832015991211,131,2.10663963807098,-0.0434996599062241 +-149.3998,58.5292556,13.719616,266897.971619091,957107.793391641,127.486198425293,131,2.10546317087056,-0.0477729245753174 +-149.33617,58.5269457,13.719616,270601.790719224,957107.770597954,129.130569458008,131,2.11102906624282,-0.0275560039185629 +-149.27255,58.5246043,13.719616,274305.52595236,957107.761690295,132.370346069336,131,2.12179070428127,0.0115333371143982 +-149.20893,58.5222311,13.719616,278009.765651163,957107.774628732,115.825042724609,131,2.06380246907427,-0.199096484647571 +-149.14532,58.5198263,13.719616,281713.935674167,957107.790519201,115.77751159668,131,2.06362421105006,-0.199743968671429 +-149.08172,58.5173898,13.719616,285418.043532501,957107.797789115,115.11506652832,131,2.06113216882432,-0.208795777334973 +-149.01814,58.5149216,13.719616,289121.516680705,957107.752494219,116.008323669434,131,2.06448915124429,-0.196602259007488 +-148.95456,58.5124218,13.719616,292825.519501424,957107.751897529,117.895988464355,131,2.07149902801762,-0.171140385748718 +-148.89098,58.5098904,13.719616,296530.058672214,957107.797293036,118.78311920166,131,2.07475472550644,-0.15931476320074 +-148.82742,58.5073273,13.719616,300233.983218865,957107.788432355,119.063629150391,131,2.07577911604513,-0.155593884374045 +-148.76387,58.5047326,13.719616,303937.878225632,957107.780204653,120.104393005371,131,2.079558892691,-0.141864656740588 +-148.70033,58.5021063,13.719616,307641.75036314,957107.772278937,124.777328491211,131,2.09613568305788,-0.0816530226410302 +-148.6368,58.4994484,13.719616,311345.606299651,957107.764340257,121.164688110352,134,2.08337606873037,-0.127999583835076 +-148.57327,58.4967588,13.719616,315050.032872719,957107.792390964,129.680450439453,134,2.11287451034624,-0.020852824192762 +-148.50976,58.4940377,13.719616,318753.876413046,957107.784104296,312.873413085938,231,2.49536865985234,1.36847510151292 +-148.44626,58.491285,13.719616,322457.723742664,957107.774956019,612.277465820312,430,2.78694827601261,2.42757549251522 +-136.38901,57.3646574,12.05966729,1044738.03549988,957107.839266291,680.895385742188,450,2.83308039108318,2.59514050186811 +-136.32948,57.3559483,13.719616,1048441.62877286,957107.731771158,198.905136108398,250,2.29864599757761,0.653922241893077 +-136.26997,57.3472104,13.719616,1052145.74908371,957107.763227278,184.977188110352,150,2.2671181733292,0.5394041852859 +-136.21049,57.3384438,13.719616,1055849.81912206,957107.785945692,174.037445068359,150,2.2406426990699,0.443237705923406 +-136.15104,57.3296484,13.719616,1059553.84672187,957107.788022798,154.306533813477,150,2.18838431581727,0.253420341922273 +-136.09162,57.3208244,13.719616,1063257.8308268,957107.789858808,135.525817871094,150,2.13202203684052,0.0486964572826545 +-136.03223,57.3119716,13.719616,1066961.78223306,957107.768808853,114.595664978027,150,2.05916818908224,-0.215929512333858 +-135.97287,57.3030902,13.719616,1070665.69983384,957107.745281797,111.896827697754,150,2.04881777434882,-0.253525172948117 +-135.91354,57.2941802,13.71359343,1074369.58844564,957107.718168751,48.0696563720703,50,1.68187101756765,-1.58638053060915 +-135.85423,57.2852416,10.2184576,1078074.03213847,957107.84870404,26.4734287261963,50,1.42281019292331,-2.52736338903841 +-135.38089,57.2127045,6.885393059,1107705.77080486,957107.774439828,59.6412124633789,50,1.77554646376826,-1.24612457237425 +-153.67697,58.5784506,13.719616,18729.9846746842,953403.77493621,13.7648000717163,20,1.13876990781936,-3.55907877770483 +-153.61309,58.5782735,13.719616,22433.9634092942,953403.780052913,26.2626953125,20,1.41933929522174,-2.53997068018335 +-153.54921,58.5780644,13.71924308,26137.983738909,953403.771863033,89.9489898681641,20,1.95399629055933,-0.597943866817541 +-153.48533,58.5778235,13.719616,29842.0523828127,953403.772827756,107.233772277832,132,2.03033158390177,-0.32067229313588 +-153.42146,58.5775508,13.719616,33545.5963515426,953403.778021898,126.932586669922,132,2.10357313032297,-0.0546380913154184 +-153.35758,58.5772461,13.719616,37249.7823233922,953403.774781953,146.323913574219,132,2.16531530824856,0.169627121882385 +-153.2937,58.5769096,13.719616,40954.0371351775,953403.781125205,158.954376220703,132,2.20127248910729,0.300233865962505 +-153.22983,58.5765412,13.719616,44657.7879262343,953403.779328035,176.18132019043,132,2.24595985998821,0.46255115204752 +-153.16596,58.5761409,13.719616,48361.6213727341,953403.775192565,167.688201904297,132,2.22450250787677,0.38461192464073 +-153.10209,58.5757087,13.719616,52065.5443332346,953403.768928637,161.364990234375,132,2.20780931602859,0.323977487136825 +-153.03822,58.5752447,13.719616,55769.5635040549,953403.771937601,156.793365478516,132,2.19532768209185,0.278640630065581 +-152.97435,58.5747488,13.719616,59473.6858832996,953403.773287587,154.726119995117,132,2.18956363504518,0.257703965969247 +-152.91048,58.574221,13.719616,63177.9183282732,953403.773238537,179.904541015625,132,2.25504212561981,0.495540533158188 +-152.84662,58.5736614,13.719616,66881.687684461,953403.773170498,209.002349853516,132,2.32015116899468,0.732035162666904 +-152.78276,58.5730699,13.719616,70585.5807980408,953403.771157513,134.276138305664,132,2.12799884272896,0.0340830679355436 +-152.7189,58.5724465,13.719616,74289.6045248051,953403.767509595,46.5459938049316,30,1.66788230737355,-1.63719151880952 +-152.65504,58.5717913,9.775593265,77993.7654936544,953403.773727109,16.819019317627,30,1.22580066938343,-3.24295821065164 +-152.33579,58.5680373,11.67758452,96513.9714449127,953403.780984495,29.0431728363037,30,1.4630440593431,-2.38122250231296 +-152.27195,58.5671909,13.71755197,100217.940749918,953403.776517657,30.3876876831055,30,1.4826976541874,-2.309835036144 +-152.20812,58.5663127,13.719616,103921.515308401,953403.766787423,67.0929565429688,30,1.82667693007837,-1.06040412464788 +-152.14428,58.5654027,13.719616,107625.86157232,953403.782991691,68.7465133666992,30,1.8372506768441,-1.02199725834692 +-152.08045,58.5644607,13.719616,111329.827369725,953403.771409458,97.522834777832,132,1.98910631679487,-0.470414230130861 +-152.01662,58.563487,13.719616,115033.998396883,953403.781696008,155.444534301758,132,2.19157545610377,0.265011474284933 +-151.9528,58.5624814,13.719616,118737.802308101,953403.774138922,155.186065673828,132,2.19085272289738,0.262386300990748 +-151.88898,58.561444,13.719616,122441.8254116,953403.777198751,163.14289855957,132,2.21256817414893,0.341263018143244 +-151.82516,58.5603747,13.719616,126146.074886306,953403.780247758,155.411987304688,132,2.19148451394686,0.26468114641357 +-151.76135,58.5592737,13.719616,129849.977005877,953403.786632353,189.120086669922,132,2.27673765822961,0.57434490011852 +-151.69755,58.5581407,13.719616,133553.539711301,953403.761746087,184.246917724609,132,2.26540023125896,0.533164129337272 +-151.63374,58.556976,13.719616,137257.92831713,953403.779352009,171.202621459961,132,2.23351041032291,0.41733119743644 +-151.56994,58.5557795,13.719616,140961.990374426,953403.788110971,172.479782104492,132,2.23673819485824,0.429055432170212 +-151.50615,58.5545511,13.719616,144665.73311061,953403.77580679,169.617126464844,132,2.22946970142102,0.402654189371639 +-151.44236,58.5532909,13.719616,148369.74275154,953403.774917725,162.134246826172,132,2.20987475844334,0.331479763523158 +-151.37857,58.5519989,13.719616,152074.026102795,953403.786101909,158.697189331055,132,2.20056923507985,0.297679446606151 +-151.31479,58.5506751,13.719616,155778.010151503,953403.786577368,161.982452392578,132,2.2094679698399,0.330002191206442 +-151.25102,58.5493195,13.719616,159481.70170085,953403.775362087,161.387451171875,132,2.20786976273621,0.324197046832124 +-151.18725,58.5479321,13.719616,163185.687370053,953403.776062645,162.400344848633,132,2.21058694710774,0.33406663603114 +-151.12348,58.5465128,13.719616,166889.974443705,953403.77823799,162.926361083984,132,2.21199135777133,0.33916785642003 +-151.05972,58.5450618,13.719616,170593.988946828,953403.779272362,159.104202270508,132,2.20168165041208,0.301720056607788 +-150.99597,58.5435791,13.719616,174297.737645335,953403.778248343,161.574111938477,132,2.20837177758385,0.326020508048061 +-150.93222,58.5420645,13.719616,178001.80815318,953403.778740346,156.555358886719,131,2.19466793809856,0.276244251572279 +-150.86848,58.5405181,13.719616,181705.626953803,953403.765342667,149.283935546875,131,2.17401307578453,0.201219896163077 +-150.80474,58.53894,13.719616,185409.78012089,953403.77627008,139.051467895508,131,2.14317557784997,0.0892093017665411 +-150.74101,58.5373301,13.719616,189113.695145733,953403.772705681,136.024810791016,131,2.13361813047961,0.0544939249503242 +-150.67728,58.5356884,13.719616,192817.958636602,953403.782849871,140.952774047852,131,2.1490736275068,0.110632701591105 +-150.61356,58.534015,13.719616,196521.996996131,953403.78912816,132.671356201172,131,2.12277716863264,0.015116457203548 +-150.54985,58.5323098,13.719616,200225.817560519,953403.779577571,127.376083374023,131,2.10508789084262,-0.0491360487523602 +-150.48614,58.5305728,13.719616,203930.006933457,953403.784121091,114.728096008301,131,2.05966978622879,-0.214107568327494 +-150.42244,58.5288041,13.719616,207633.9914808,953403.783558549,101.960472106934,131,2.0084318377129,-0.40021842210374 +-150.35875,58.5270037,13.719616,211337.777953675,953403.777136771,105.876388549805,131,2.02479911907018,-0.340767784526888 +-150.29506,58.5251715,13.719616,215041.953541976,953403.785341138,102.415954589844,131,2.01036761729016,-0.393187118152637 +-150.23138,58.5233076,13.719616,218745.944574534,953403.787345677,100.660736083984,131,2.00286010186128,-0.420456557048565 +-150.16771,58.5214119,13.719616,222449.758442021,953403.771289273,105.643859863281,131,2.0238442604514,-0.344236103574088 +-150.10404,58.5194845,13.719616,226153.981082964,953403.781696078,105.258087158203,131,2.02225547337473,-0.350007031721534 +-150.04038,58.5175255,13.719616,229858.038756839,953403.796112182,110.087959289551,131,2.04173982124183,-0.279234318881662 +-149.97673,58.5155346,13.719616,233561.940202306,953403.780415366,123.679107666016,131,2.09229634318871,-0.0955986009025635 +-149.91309,58.5135121,13.719616,237265.690160664,953403.76743394,140.623031616211,131,2.14805645642112,0.106938045878388 +-149.84945,58.5114579,13.719616,240969.875852342,953403.781674265,143.809860229492,131,2.1577886641863,0.142288202330169 +-149.78582,58.509372,13.719616,244673.924195454,953403.787361005,143.343353271484,131,2.15637755982564,0.137162668522964 +-149.7222,58.5072544,13.719616,248377.841923488,953403.783904197,147.912902832031,131,2.17000606030071,0.186665272209758 +-149.65859,58.5051051,13.719616,252081.635768004,953403.77073015,133.717849731445,131,2.12618938424362,0.0275105982459194 +-149.59498,58.5029241,13.719616,255785.892275875,953403.785796971,149.28727722168,131,2.17402279722362,0.201255207204593 +-149.53138,58.5007114,13.719616,259490.038357476,953403.791163418,144.591278076172,131,2.16014209657101,0.15083654048792 +-149.4678,58.4984671,13.719616,263193.500159103,953403.75782289,134.172012329102,131,2.12766193342856,0.03285931719301 +-149.40421,58.4961911,13.719616,266898.024596855,953403.793008808,133.546539306641,131,2.12563263829896,0.0254883380638095 +-149.34064,58.4938834,13.719616,270601.87894048,953403.777335573,130.287933349609,131,2.11490419528015,-0.0134804291830328 +-149.27708,58.4915441,13.719616,274305.648932596,953403.76110498,125.424209594727,131,2.09838137284724,-0.0734960363423867 +-149.21352,58.4891732,13.719616,278009.921075786,953403.785716477,130.852767944336,131,2.11678291375647,-0.00665638743740706 +-149.14998,58.4867706,13.719616,281713.543234119,953403.756411954,111.051704406738,131,2.04552522842939,-0.26548463951365 +-149.08644,58.4843364,13.719616,285417.68092905,953403.768189932,118.965965270996,131,2.07542273274426,-0.15688837024473 +-149.02291,58.4818706,13.719616,289121.761022134,953403.778774305,119.09114074707,131,2.07587945528826,-0.155229423603331 +-148.95939,58.4793731,13.719616,292825.791037354,953403.776623919,117.732521057129,131,2.07089644385271,-0.173329143430297 +-148.89588,58.476844,13.719616,296529.77682298,953403.772501538,120.047019958496,131,2.07935138362133,-0.142618388910608 +-148.83238,58.4742833,13.719616,300233.725051072,953403.766041258,121.07918548584,131,2.08306949074345,-0.129113162589648 +-148.76889,58.4716911,13.719616,303937.641512037,953403.768033784,122.826522827148,131,2.0892921573078,-0.106510661502063 +-148.70541,58.4690672,13.719616,307641.534621339,953403.755863335,127.840393066406,131,2.10666809728209,-0.0433962879283794 +-148.64193,58.4664117,13.719616,311345.989992601,953403.787235144,124.383476257324,134,2.09476269026715,-0.0866401243481152 +-148.57847,58.4637247,13.719616,315049.85374269,953403.779779862,136.21272277832,134,2.13421767420204,0.0566716388770054 +-148.51502,58.4610061,13.719616,318753.713239111,953403.768395907,311.599273681641,231,2.49359643668851,1.36203788113906 +-148.45158,58.4582559,13.719616,322457.575139673,953403.752813442,490.052032470703,430,2.6902421947534,2.07631140271812 +-136.34568,57.3239386,13.14906582,1048442.0775866,953403.8553649,533.919860839844,351,2.7274760761168,2.21155548743779 +-136.28623,57.3152082,13.719616,1052145.57970682,953403.712462642,201.438095092773,250,2.30414160586045,0.67388385977911 +-136.2268,57.3064492,13.719616,1055849.60456556,953403.725970029,185.141616821289,150,2.26750405205556,0.540805806960796 +-136.1674,57.2976614,13.719616,1059553.58310941,953403.715331884,172.800079345703,150,2.23754393756066,0.431982119647253 +-136.10803,57.288845,13.719616,1063257.51428706,953403.700941865,153.608322143555,150,2.18641474540328,0.246266300007272 +-136.04868,57.2799999,13.719616,1066961.98572498,953403.831565889,135.270782470703,150,2.13120400219985,0.0457251219774213 +-135.98937,57.2711261,13.719616,1070665.84263953,953403.785323462,113.218147277832,150,2.05391604373355,-0.23500680335183 +-135.93009,57.2622238,13.719616,1074369.66369232,953403.742715394,53.421215057373,50,1.72771376175932,-1.41986659888312 +-135.87083,57.2532928,12.4878044,1078074.03950163,953403.84345971,35.2666969299316,50,1.54736478565899,-2.07494555680221 +-135.81161,57.2443333,3.878727362,1081777.80922701,953403.783853707,34.7841796875,50,1.54138176588275,-2.0966775923534 +-135.33889,57.1716305,6.608866821,1111409.93652499,953403.812466951,131.086288452148,50,2.11755726712108,-0.00384371499466986 +-153.86874,58.5456481,13.719616,7618.01214619456,949699.778974997,17.336742401123,20,1.23896749624713,-3.19513253729614 +-153.80492,58.5455666,13.719616,11321.9880521314,949699.771274407,46.0227394104004,20,1.66297246560191,-1.6550254655325 +-153.7411,58.5454534,13.69893914,15025.9848190781,949699.780375863,41.2356948852539,20,1.61527331749472,-1.82828238615011 +-153.67728,58.5453082,13.71077551,18730.0094026924,949699.772811556,26.0686645507812,20,1.41611878363929,-2.55166849747632 +-153.61346,58.5451313,13.719616,22434.0684971045,949699.782184362,77.482780456543,20,1.88920519691113,-0.833283612167067 +-153.54965,58.5449224,13.719616,26137.5887471455,949699.771124317,114.055061340332,132,2.05711456241762,-0.223388870543162 +-153.48583,58.5446818,13.719616,29841.7375321812,949699.780581073,128.519744873047,132,2.10896985475422,-0.0350356478026105 +-153.42201,58.5444092,13.719616,33545.9415610841,949699.773776137,139.203079223633,132,2.14364884213547,0.0909283327345499 +-153.3582,58.5441049,13.719616,37249.6270233467,949699.778769252,152.138885498047,132,2.18224023048203,0.231103270288107 +-153.29438,58.5437686,13.719616,40953.9618167675,949699.772854006,177.891799926758,132,2.2501559293732,0.477792473731249 +-153.23057,58.5434006,13.719616,44657.7916908412,949699.777956125,174.400772094727,132,2.24154840327853,0.446527482122857 +-153.16676,58.5430007,13.719616,48361.7040919588,949699.777526848,166.20149230957,132,2.22063491896014,0.370563737775753 +-153.10295,58.5425689,13.719616,52065.7058751505,949699.771775535,162.548263549805,132,2.21098233443032,0.335502795641551 +-153.03914,58.5421053,13.719616,55769.8037333712,949699.772102859,159.89323425293,132,2.20383008733107,0.309523792722507 +-152.97533,58.5416099,13.719616,59474.0044886397,949699.778751074,165.40983581543,132,2.21856133056937,0.363031872879444 +-152.91153,58.5410826,13.719616,63177.734770695,949699.771291673,190.15348815918,132,2.27910429648118,0.582941205754016 +-152.84773,58.5405235,13.719616,66881.5816139461,949699.769572439,197.814849853516,132,2.2962588907362,0.645251588496957 +-152.78393,58.5399326,13.719616,70585.5518389966,949699.773885495,60.0340538024902,132,1.77839767010268,-1.23576817715233 +-152.72013,58.5393098,13.719616,74289.6524812766,949699.773365933,34.12353515625,30,1.53305401720011,-2.12692635254486 +-152.33739,58.5349047,13.31696417,96513.8920232004,949699.779744439,62.8384552001953,30,1.79822549994723,-1.16374783973084 +-152.27361,58.5340591,13.71520458,100217.93502453,949699.777785215,35.6980285644531,30,1.55264423271666,-2.05576909818455 +-152.20984,58.5331817,13.55429171,103921.58245499,949699.767357157,38.5472793579102,30,1.58599373124449,-1.9346342006369 +-152.14606,58.5322725,13.719616,107626.001878543,949699.77965721,41.4039535522461,30,1.61704181271379,-1.82185870673568 +-152.08229,58.5313315,13.719616,111330.039358325,949699.783305854,40.5429191589355,30,1.607915015422,-1.85500983954676 +-152.01853,58.5303587,13.719616,115033.701706615,949699.777121161,111.247840881348,132,2.04629159086721,-0.262700992397879 +-151.95477,58.529354,13.719616,118737.576453926,949699.766646699,171.119689941406,132,2.23329998464868,0.416566871326201 +-151.89101,58.5283176,13.719616,122441.669733233,949699.774747902,170.420532226562,132,2.23152191728229,0.410108423140514 +-151.82725,58.5272493,13.719616,126145.989053035,949699.779625438,182.485076904297,132,2.26122735491244,0.518007051389257 +-151.7635,58.5261493,13.719616,129849.960126496,949699.784624088,173.474700927734,132,2.23923614743457,0.438128708914078 +-151.69976,58.5250174,13.719616,133553.590503037,949699.766305775,176.343322753906,132,2.24635901973907,0.464001014194178 +-151.63601,58.5238538,13.719616,137258.046975901,949699.787261961,182.768920898438,132,2.26190234768971,0.520458817818395 +-151.57228,58.5226583,13.719616,140961.596010304,949699.763758624,180.229354858398,132,2.25582552812331,0.498386074656267 +-151.50854,58.5214311,13.719616,144665.984729466,949699.780759867,175.541519165039,132,2.24437985249237,0.456812113843589 +-151.44481,58.5201721,13.719616,148370.05958439,949699.784728327,168.386322021484,132,2.226306810965,0.391165668456559 +-151.38109,58.5188813,13.719616,152073.827377201,949699.774647496,163.140899658203,132,2.21256285294182,0.341243690000193 +-151.31737,58.5175588,13.719616,155777.874832549,949699.78414047,150.998901367188,132,2.17897378747924,0.219238616966319 +-151.25366,58.5162044,13.719616,159481.629267082,949699.767549282,149.826248168945,132,2.17558790439374,0.20694012317253 +-151.18995,58.5148183,13.719616,163185.676940987,949699.770811457,138.799789428711,132,2.14238880725703,0.086351526406294 +-151.12624,58.5134004,13.719616,166890.025102826,949699.783483269,127.766456604004,132,2.10641685050549,-0.044308887933962 +-151.06255,58.5119508,13.719616,170593.519304413,949699.766093347,136.13737487793,132,2.13397737189645,0.0557987923139874 +-150.99885,58.5104694,13.719616,174297.907938118,949699.783621232,137.196472167969,132,2.13734294418646,0.0680235115012631 +-150.93516,58.5089562,13.719616,178002.037047233,949699.784906212,122.93970489502,131,2.0896921663038,-0.105057714654631 +-150.87148,58.5074113,13.719616,181705.912897407,949699.780226687,116.395805358887,131,2.06593732960671,-0.191342061843919 +-150.80781,58.5058347,13.719616,185409.542247033,949699.768712922,107.075057983398,131,2.02968831824828,-0.323008817595656 +-150.74414,58.5042263,13.719616,189113.512775744,949699.766825757,103.000946044922,131,2.01284121363918,-0.384202310178307 +-150.68047,58.5025861,13.719616,192817.831271142,949699.775403036,100.278511047363,131,2.00120787685464,-0.426457909864639 +-150.61681,58.5009143,13.719616,196521.92300621,949699.788029212,90.9665145874023,31,1.95888155489043,-0.580199192373731 +-150.55316,58.4992107,13.719616,200225.795860875,949699.781577638,85.2614898681641,31,1.93075291728448,-0.68237043287103 +-150.48951,58.4974753,13.719616,203930.036993173,949699.785969405,86.7627563476562,31,1.93833334057086,-0.654836171826675 +-150.42587,58.4957083,13.719616,207634.071607259,949699.793161451,93.7330703735352,31,1.97189284325526,-0.532938479241206 +-150.36224,58.4939095,13.719616,211337.907642512,949699.780079644,93.3895721435547,131,1.97029838572321,-0.538730004101115 +-150.29862,58.492079,13.719616,215041.551254609,949699.757145017,89.4384078979492,131,1.95152405969162,-0.606923714974015 +-150.235,58.4902169,13.719616,218745.588929806,949699.767730654,86.0896759033203,131,1.93495107285834,-0.667121533553851 +-150.17138,58.488323,13.719616,222450.028666641,949699.790488212,95.6305084228516,131,1.98059646472375,-0.501324441806777 +-150.10778,58.4863974,13.719616,226153.715833654,949699.769451801,97.9496154785156,131,1.99100273542124,-0.463525896388098 +-150.04418,58.4844402,13.719616,229857.817254893,949699.782652919,105.406394958496,131,2.0228669601264,-0.347785937303762 +-149.98059,58.4824512,13.719616,233561.76061277,949699.77362677,110.943641662598,131,2.04510241724873,-0.267020410404136 +-149.91701,58.4804306,13.719616,237265.551301807,949699.764042686,130.641540527344,131,2.11608129296698,-0.00920487440734702 +-149.85343,58.4783783,13.719616,240969.77709619,949699.778405015,133.036041259766,131,2.12396931314608,0.0194466663482652 +-149.78986,58.4762943,13.719616,244673.864352977,949699.780936193,134.41374206543,131,2.12844367197744,0.0356988147329343 +-149.7263,58.4741787,13.719616,248377.819083675,949699.782196076,152.417343139648,131,2.18303438695967,0.23398787328973 +-149.66275,58.4720314,13.719616,252081.648713846,949699.770455179,155.744445800781,131,2.1924125676838,0.268052102479063 +-149.5992,58.4698524,13.719616,255785.94034479,949699.783669236,155.504501342773,131,2.19174296493863,0.265619914184953 +-149.53567,58.4676418,13.719616,259489.539200179,949699.755971291,153.213577270508,131,2.18529725271426,0.242207247596591 +-149.47214,58.4653996,13.719616,263193.612720346,949699.764420566,146.854400634766,131,2.16688696510983,0.175335828198044 +-149.40862,58.4631257,13.719616,266897.587990584,949699.758839664,145.691024780273,131,2.16343279810861,0.16278930773223 +-149.3451,58.4608202,13.719616,270602.051321491,949699.790627719,136.543838500977,131,2.135272107512,0.0605016416240048 +-149.2816,58.4584831,13.719616,274305.848647246,949699.778368314,137.588928222656,131,2.13858348764029,0.0725295194119246 +-149.21811,58.4561144,13.719616,278009.567024921,949699.761785141,138.82893371582,131,2.14247998804679,0.0866827210602613 +-149.15462,58.453714,13.719616,281713.794324069,949699.771703613,128.31803894043,131,2.10828771375292,-0.0375133786217913 +-149.09114,58.4512821,13.719616,285417.955228892,949699.788678101,124.416862487793,131,2.094879245219,-0.086216763494907 +-149.02767,58.4488186,13.719616,289122.057218934,949699.801145662,120.607940673828,131,2.08137590214326,-0.135264759783855 +-148.96422,58.4463234,13.719616,292825.527439134,949699.753469707,120.246536254883,131,2.08007257521588,-0.139998815190637 +-148.90077,58.4437967,13.719616,296529.531628131,949699.755180301,121.927604675293,131,2.08610204196731,-0.118098070968286 +-148.83732,58.4412384,13.719616,300234.077290684,949699.796438257,122.582550048828,131,2.08842865161077,-0.109647160662739 +-148.77389,58.4386486,13.719616,303938.009464859,949699.79817225,127.862892150879,131,2.10674452358418,-0.0431186857849822 +-148.71047,58.4360271,13.719616,307641.916936201,949699.782414727,129.410018920898,134,2.1119679007038,-0.0241458891862337 +-148.64706,58.4333742,13.719616,311345.803699201,949699.782263532,128.73030090332,134,2.10968078440419,-0.0324533483943979 +-148.58366,58.4306896,13.719616,315049.679080707,949699.763995515,139.733963012695,134,2.14530197630984,0.096932987907335 +-148.52027,58.4279736,13.719616,318753.547006613,949699.76073519,203.717102050781,231,2.30902748955251,0.691630783918724 +-148.45688,58.425226,13.719616,322457.996306067,949699.798487338,455.023773193359,430,2.65803408741971,1.95932236377305 +-136.30245,57.2832029,13.719616,1052146.04269615,949699.839286479,271.106048583984,351,2.43313920713174,1.14243996717752 +-136.24307,57.2744514,13.719616,1055850.02050662,949699.833885609,200.959503173828,250,2.30310854836517,0.670131500092278 +-136.18372,57.2656713,13.719616,1059553.94222833,949699.822367591,184.916687011719,150,2.26697610396668,0.538888148810588 +-136.1244,57.2568624,13.719616,1063257.81863244,949699.782056044,163.948776245117,150,2.21470817933429,0.349036127794755 +-136.06511,57.2480249,13.719616,1066961.64864749,949699.733342477,149.084365844727,150,2.17343210231705,0.199109634702837 +-136.00584,57.2391588,13.719616,1070666.01747019,949699.836311631,125.684669494629,150,2.09928230743993,-0.0702235847494295 +-135.94661,57.2302641,13.719616,1074369.76916628,949699.767961697,71.5395431518555,50,1.85454616243775,-0.959175118047726 +-135.8874,57.2213408,12.24619012,1078074.06929548,949699.850172599,50.5325317382812,50,1.70357105743912,-1.50755979198794 +-135.82823,57.212389,7.847274939,1081777.75889494,949699.76847885,13.5452556610107,50,1.13178720657246,-3.58444194169494 +-135.4738,57.1580793,9.940093623,1104001.86368358,949699.794540182,85.5270462036133,50,1.93210347331963,-0.677464827864299 +-135.41483,57.1489281,9.186266566,1107706.0527263,949699.847361831,100.498420715332,50,2.00215923707983,-0.423002297981494 +-153.86887,58.5125046,13.719616,7617.78089048546,945995.77156208,23.3181591033936,20,1.36769426123295,-2.72756018459091 +-153.80511,58.5124233,13.719616,11321.8306095676,945995.777674228,46.0286026000977,20,1.66302779018229,-1.65482451086534 +-153.74135,58.5123101,13.719616,15025.9012230937,945995.775041283,66.5265655517578,20,1.82299510347881,-1.07377756975541 +-153.67759,58.5121651,13.719616,18729.9995304491,945995.774897826,81.8808517456055,20,1.91318235165647,-0.746191742370676 +-153.61384,58.5119883,13.719616,22433.5514202322,945995.773941547,120.17293548584,132,2.0798066698911,-0.140964659227157 +-153.55008,58.5117797,13.719616,26137.7255791033,945995.77846304,133.498489379883,132,2.12547635141076,0.0249206594771306 +-153.48632,58.5115392,13.719616,29841.9479817736,945995.774575778,142.754379272461,132,2.15458943996301,0.130667706801694 +-153.42257,58.511267,13.719616,33545.6443541557,945995.779704469,147.02424621582,132,2.16738896147895,0.177159222294717 +-153.35881,58.5109629,13.719616,37249.9835658965,945995.781185728,175.524307250977,132,2.24433726766215,0.456657433585322 +-153.29506,58.510627,13.719616,40953.8104853789,945995.779693261,173.931304931641,132,2.24037775529483,0.442275354509884 +-153.23131,58.5102593,13.719616,44657.7128653438,945995.780453663,169.032119750977,132,2.22796923778041,0.397204077153997 +-153.16756,58.5098597,13.719616,48361.6976655427,945995.772484265,166.664657592773,132,2.22184351440657,0.374953701404675 +-153.10381,58.5094284,13.719616,52065.7714358717,945995.778342979,164.331665039062,132,2.21572125562446,0.35271591004143 +-153.04006,58.5089652,13.719616,55769.9412861519,945995.775905889,160.897979736328,132,2.20655059105445,0.319405438754874 +-152.97632,58.5084703,13.719616,59473.632789837,945995.778808103,170.812316894531,132,2.23251918348687,0.413730778643634 +-152.91257,58.5079435,13.719616,63178.0149642666,945995.782312571,197.714080810547,132,2.29603760001959,0.644447797451541 +-152.84883,58.5073849,13.719616,66881.9326000507,945995.779399992,188.564910888672,132,2.27546088020824,0.569707277916183 +-152.78509,58.5067945,13.71845154,70585.9734470343,945995.779317311,72.4219818115234,35,1.8598704050161,-0.939835949313038 +-152.72136,58.5061723,13.719616,74289.5633890587,945995.771186264,76.9976196289062,30,1.8864772992243,-0.84319211518518 +-152.65762,58.5055183,11.51927146,77993.8711076189,945995.77714651,15.1466655731201,30,1.18031703662846,-3.40816774713898 +-152.40271,58.5025843,9.960892302,92809.7020552938,945995.772812902,15.2937688827515,30,1.18451452290639,-3.39292127889569 +-152.33899,58.5017713,13.719616,96513.6343460081,945995.769682642,93.5701599121094,30,1.97113737168999,-0.535682567599341 +-152.27527,58.5009265,13.70713015,100217.744363233,945995.770080219,19.8446960449219,30,1.29764445133972,-2.98200108832946 +-152.21155,58.50005,13.71353291,103922.038617335,945995.785617661,31.8837966918945,30,1.50357003117331,-2.23402060536164 +-152.14784,58.4991416,13.719616,107625.943577176,945995.778203106,38.9553718566895,30,1.59056735435402,-1.91802149606107 +-152.08413,58.4982015,13.719616,111330.046372606,945995.785743271,37.7869529724121,30,1.57734187311257,-1.96606021885821 +-152.02043,58.4972296,13.719616,115033.773180616,945995.780235546,60.7809066772461,30,1.78376717422349,-1.21626460557648 +-151.95673,58.4962259,13.719616,118737.711741872,945995.778392755,102.720962524414,132,2.01165908020573,-0.388496156223061 +-151.89303,58.4951904,13.719616,122441.868863388,945995.780738228,187.22184753418,132,2.27235652661313,0.558431379588009 +-151.82934,58.4941231,13.719616,126145.670418508,945995.76881712,203.430755615234,132,2.30841661222609,0.689411903107416 +-151.76565,58.4930241,13.719616,129849.703769158,945995.772234093,176.768508911133,132,2.24740489854884,0.467799944554792 +-151.70196,58.4918933,13.719616,133553.976073938,945995.780392268,155.704483032227,132,2.19230111692348,0.267647281506357 +-151.63828,58.4907308,13.719616,137257.912805863,945995.784381387,169.649917602539,132,2.22955365304821,0.402959125643773 +-151.57461,58.4895364,13.719616,140961.521550916,945995.760797181,163.133499145508,132,2.21254315172199,0.341172129546493 +-151.51093,58.4883104,13.719616,144665.969751385,945995.785659246,172.161331176758,132,2.23593561202815,0.42614022225136 +-151.44727,58.4870525,13.719616,148369.522633012,945995.760752614,166.019073486328,132,2.22015798583529,0.368831380536051 +-151.3836,58.485763,13.719616,152073.928504326,945995.785583979,150.481109619141,132,2.17748198495921,0.213819964410746 +-151.31994,58.4844416,13.719616,155778.033585729,945995.782083971,138.460021972656,132,2.14132439619498,0.0824852816157524 +-151.25629,58.4830886,13.719616,159481.843320937,945995.78276622,108.358238220215,132,2.03486193529193,-0.304216763795802 +-151.19264,58.4817037,13.719616,163185.946790359,945995.77773573,100.013618469238,132,2.00005914023352,-0.430630449154639 +-151.129,58.4802872,13.719616,166889.768438277,945995.776079746,84.8084716796875,31,1.92843923692621,-0.690774380322384 +-151.06536,58.4788389,13.719616,170593.896913091,945995.780218692,76.4423446655273,31,1.88333399941495,-0.854609477279826 +-151.00173,58.4773589,13.719616,174297.757568914,945995.775825182,72.9567337036133,31,1.86306538225223,-0.928230880054112 +-150.9381,58.4758471,13.719616,178001.938611321,945995.77763467,84.4305725097656,31,1.92649973416235,-0.697819207949933 +-150.87448,58.4743037,13.719616,181705.864844562,945995.781398988,89.3297576904297,31,1.95099615595397,-0.608841212027883 +-150.81087,58.4727285,13.719616,185409.54406445,945995.763920483,88.7834930419922,31,1.94833222763483,-0.618517360043839 +-150.74726,58.4711216,13.719616,189113.563442243,945995.763983677,85.9854354858398,31,1.93442489515286,-0.669032761166239 +-150.68365,58.469483,13.719616,192817.929730066,945995.782423057,83.7432403564453,31,1.9229497614477,-0.710713722112632 +-150.62005,58.4678127,13.719616,196522.068745816,945995.79049776,79.1965484619141,31,1.89870625461211,-0.798773058725256 +-150.55646,58.4661107,13.719616,200225.987238615,945995.787401719,76.5601501464844,31,1.88400277648934,-0.852180288057636 +-150.49288,58.464377,13.719616,203929.691956045,945995.772345228,79.2132797241211,31,1.89879799506739,-0.798439831206369 +-150.4293,58.4626116,13.719616,207633.770576851,945995.775819873,83.0054321289062,31,1.91910651486297,-0.724673490680148 +-150.36573,58.4608145,13.719616,211337.648912703,945995.766919109,81.4546051025391,31,1.91091564253139,-0.754425076896158 +-150.30216,58.4589857,13.719616,215041.914639122,945995.777282591,84.428840637207,31,1.9264908256546,-0.697851566192833 +-150.2386,58.4571253,13.719616,218745.992931885,945995.786078105,85.6648559570312,31,1.9328026889675,-0.674925077055206 +-150.17505,58.4552332,13.719616,222449.891141681,945995.781439036,87.5939788818359,31,1.94247425424724,-0.639795191419625 +-150.11151,58.4533094,13.719616,226153.61600623,945995.762673477,90.1789932250977,131,1.95510538245397,-0.593915328489858 +-150.04797,58.451354,13.719616,229857.754529636,945995.774872402,94.9928894042969,131,1.97769109783567,-0.511877563618548 +-149.98444,58.4493669,13.719616,233561.733156643,945995.772723971,103.382133483887,131,2.01444549040392,-0.378375119062595 +-149.92092,58.4473482,13.719616,237265.557933709,945995.766738954,116.545524597168,131,2.0664956010649,-0.189314260561223 +-149.8574,58.4452978,13.719616,240969.817188775,945995.781419721,138.002380371094,131,2.13988657751077,0.0772627137603785 +-149.79389,58.4432157,13.719616,244673.936717838,945995.780986455,148.87678527832,131,2.17282698242954,0.196911666552975 +-149.73039,58.4411021,13.719616,248377.921811834,945995.787148434,154.72395324707,131,2.18955755324523,0.2576818751359 +-149.6669,58.4389568,13.719616,252081.780588953,945995.77702076,158.112747192383,131,2.19896688455679,0.291859252150022 +-149.60342,58.4367799,13.719616,255785.519032917,945995.761191802,166.088012695312,131,2.22033828863354,0.369486291762841 +-149.53994,58.4345713,13.719616,259489.725515441,945995.767036956,158.42414855957,131,2.1998213817157,0.294963029728969 +-149.47647,58.4323312,13.719616,263193.824301655,945995.778366629,152.559539794922,131,2.18343936996436,0.23545888715641 +-149.41301,58.4300595,13.719616,266897.822815872,945995.783514486,147.914398193359,131,2.17001045088381,0.186681220060751 +-149.34956,58.4277561,13.719616,270601.728522978,945995.770833265,148.959732055664,131,2.17306888244197,0.197790316443277 +-149.28612,58.4254212,13.719616,274305.546550777,945995.762135008,146.032165527344,131,2.1644485254588,0.166478719385543 +-149.22268,58.4230546,13.719616,278009.866085244,945995.77651989,140.178024291992,131,2.14667993462361,0.101938125811396 +-149.15926,58.4206565,13.719616,281713.530341884,945995.752662853,143.663833618164,131,2.15734745124527,0.140685590993643 +-149.09584,58.4182269,13.719616,285417.707828783,945995.77440768,124.479942321777,131,2.09509937841377,-0.0854171768992348 +-149.03243,58.4157656,13.719616,289121.825923826,945995.777183536,122.627510070801,131,2.08858791008212,-0.109068688437885 +-148.96903,58.4132728,13.719616,292825.889637597,945995.782874836,120.567543029785,131,2.08123041078746,-0.135793225915457 +-148.90564,58.4107484,13.719616,296529.906462449,945995.779949856,121.418609619141,131,2.08428525540077,-0.12469715834046 +-148.84226,58.4081925,13.719616,300233.882197009,945995.779178227,122.350379943848,131,2.08760532233726,-0.112637727585693 +-148.77889,58.4056051,13.719616,303937.823472715,945995.780202016,128.006561279297,131,2.10723223101007,-0.0413471932085688 +-148.71553,58.4029861,13.719616,307641.737806943,945995.771539899,125.547431945801,134,2.09880783371024,-0.0719470087639531 +-148.65218,58.4003356,13.719616,311345.630959472,945995.764006849,130.43098449707,134,2.11538077235955,-0.0117493652019891 +-148.58884,58.3976536,13.719616,315049.509554708,945995.757292689,140.748260498047,134,2.14844303612894,0.108342213718025 +-148.5255,58.39494,13.719616,318753.962067521,945995.787963575,220.56233215332,231,2.34353134520854,0.816958636042322 +-148.46218,58.392195,13.719616,322457.831422396,945995.782578915,595.142272949219,430,2.77462079929277,2.3827985784566 +-136.31865,57.2511945,13.719616,1052145.98236422,945995.828296458,442.869079589844,351,2.64627535959774,1.91661130804862 +-136.25932,57.2424505,13.719616,1055849.90830093,945995.803943182,219.025924682617,250,2.34049552251252,0.805931661500295 +-136.20002,57.2336779,13.719616,1059553.77430036,945995.769970997,198.136260986328,150,2.29696396319712,0.647812612922738 +-136.14075,57.2248766,13.719616,1063257.58816172,945995.714457692,176.022155761719,150,2.24556733553839,0.461125391208169 +-136.0815,57.2160468,13.719616,1066961.92972262,945995.818440257,161.877471923828,150,2.20918641329981,0.328979497488587 +-136.02229,57.2071883,13.719616,1070665.64788046,945995.738493798,136.163940429688,150,2.1340621109111,0.0561065886021242 +-135.9631,57.1983012,13.719616,1074369.90635003,945995.80612792,109.961326599121,150,2.04123997063308,-0.281049918964209 +-135.90395,57.1893856,13.719616,1078073.54507095,945995.707978868,59.8012199401855,50,1.77671004365207,-1.24189811811748 +-135.84482,57.1804414,10.81282924,1081777.73369717,945995.756287686,39.191349029541,50,1.593190212853,-1.90849452535446 +-135.54963,57.1352932,10.28792025,1100297.74307387,945995.757371693,49.5053253173828,50,1.694651918763,-1.53995664943523 +-135.49068,57.1261783,13.18098517,1104001.81825857,945995.786943957,168.531066894531,50,2.22667997011667,0.392521089005653 +-135.43176,57.1170349,11.29705206,1107705.89261877,945995.804363338,35.7608833312988,50,1.55340823778525,-2.05299401370666 +-153.93269,58.4794099,12.571615,3914.01373576823,942291.771706728,14.6547622680664,20,1.16597877763598,-3.46024839634625 +-153.869,58.4793605,13.719616,7617.53510096657,942291.780665429,41.3948974609375,20,1.6169468111419,-1.82220377956094 +-153.8053,58.4792792,13.719616,11321.6519901331,942291.778224691,56.0304870605469,20,1.7484243977092,-1.34463965770913 +-153.7416,58.4791661,13.719616,15025.7897195041,942291.775012856,96.6094131469727,132,1.98501944399955,-0.485258918633083 +-153.6779,58.4790213,13.719616,18729.955052836,942291.782264009,138.54557800293,132,2.14159266884381,0.0834597244489319 +-153.61421,58.4788446,13.719616,22433.5734151632,942291.774325376,137.650299072266,132,2.13877715932029,0.0732329902331048 +-153.55051,58.4786362,13.719616,26137.8144860058,942291.779837559,144.515151977539,132,2.15991338394554,0.150005790951125 +-153.48682,58.4783959,13.719616,29841.5222424709,942291.769245432,153.187927246094,132,2.18522453985923,0.241943133752801 +-153.42312,58.4781239,13.719616,33545.8663208174,942291.7734534,132.982620239258,132,2.12379488587391,0.0188130967092357 +-153.35943,58.4778201,13.719616,37249.6906327964,942291.771883602,182.380676269531,132,2.26097882174413,0.517104307983502 +-153.29574,58.4774845,13.719616,40953.5834856795,942291.769187927,172.647232055664,132,2.23715961997138,0.430586168467844 +-153.23205,58.4771172,13.719616,44657.5515667455,942291.776715857,172.9765625,132,2.23798726228211,0.43359240157304 +-153.16836,58.476718,13.719616,48361.6019399003,942291.772309812,170.228134155273,132,2.2310313389368,0.408326502564672 +-153.10467,58.4762871,13.719616,52065.7411518088,942291.778526754,167.517501831055,132,2.22406018780016,0.38300529187177 +-153.04098,58.4758243,13.719616,55769.9763085062,942291.773242807,169.915725708008,132,2.23023357470285,0.405428795162381 +-152.9773,58.4753298,13.719616,59473.7324225169,942291.770092067,178.370651245117,132,2.25132339796141,0.48203305287233 +-152.91362,58.4748036,13.719616,63177.5977667604,942291.777171795,216.944686889648,132,2.33634901845342,0.790870375227562 +-152.84994,58.4742455,13.719616,66881.5795102428,942291.772408666,41.5664939880371,35,1.6187433945841,-1.81567807570289 +-152.72258,58.473034,13.1681139,74289.9187176529,942291.773228938,30.1945018768311,30,1.47992786938305,-2.31989568512868 +-152.59524,58.4716955,9.113605461,81697.6410934655,942291.772820505,22.1172866821289,30,1.34473184725938,-2.81096622626841 +-152.53157,58.4709786,5.127072862,85401.7241384341,942291.7777764,24.7543601989746,30,1.39365170604033,-2.63327533605814 +-152.4679,58.4702299,8.657686469,89105.9642408803,942291.782940633,13.1530504226685,30,1.11902648500072,-3.63079252471607 +-152.40424,58.4694494,13.69134301,92809.7867203306,942291.774728277,116.712829589844,30,2.06711859823752,-0.187051357009182 +-152.34058,58.4686372,13.719616,96513.7795973483,942291.7775773,122.759338378906,30,2.08905453910188,-0.107373758648941 +-152.27692,58.4677932,13.719616,100217.949938287,942291.780738656,119.829917907715,30,2.07856526179364,-0.145473807770296 +-152.21327,58.4669174,13.719616,103921.723060473,942291.769003796,80.1736221313477,30,1.90403150485374,-0.779430229869909 +-152.14962,58.4660099,13.719616,107625.68695006,942291.76853257,79.9921112060547,30,1.90304715913429,-0.783005654483194 +-152.08597,58.4650707,13.719616,111329.848381116,942291.779796815,94.9652633666992,30,1.97756477700558,-0.512336396928986 +-152.02233,58.4640997,13.719616,115033.632969125,942291.774793155,142.702697753906,30,2.15443218340589,0.130096506100728 +-151.95869,58.4630969,13.719616,118737.629009021,942291.7702333,99.0413589477539,30,1.99581659067707,-0.446040600087853 +-151.89505,58.4620624,13.719616,122441.842950205,942291.777809035,90.2077178955078,30,1.95524369603463,-0.593412934086283 +-151.83142,58.4609961,13.719616,126145.700437553,942291.767894156,185.192855834961,132,2.26762422893717,0.541242323696693 +-151.76779,58.4598982,13.719616,129849.789012088,942291.781260719,192.905715942383,132,2.28534509630878,0.605609572029477 +-151.70417,58.4587684,13.719616,133553.535078519,942291.764862719,188.702072143555,132,2.27577666919286,0.570854313643471 +-151.64055,58.457607,13.719616,137257.52576821,942291.771788273,185.874237060547,132,2.2692191989284,0.547035709954588 +-151.57693,58.4564138,13.719616,140961.768630821,942291.780304337,169.981231689453,132,2.23040097182722,0.406036829297996 +-151.51332,58.4551888,13.719616,144665.688973369,942291.769248613,170.822540283203,132,2.23254517592408,0.413825190594579 +-151.44971,58.4539322,13.719616,148369.874224627,942291.782260178,167.471786499023,132,2.22394165316485,0.382574740243164 +-151.38611,58.4526438,13.719616,152073.750504645,942291.774758811,162.236679077148,132,2.21014904790207,0.332476061127269 +-151.32251,58.4513237,13.719616,155777.90564754,942291.780364258,131.435623168945,132,2.11871308857959,0.000354558446930287 +-151.25892,58.4499719,13.719616,159481.764923622,942291.775747684,110.166366577148,132,2.04204902609988,-0.278111198581345 +-151.19533,58.4485884,13.719616,163185.916582928,942291.784509861,108.294502258301,132,2.03460640953864,-0.305144906266064 +-151.13175,58.4471731,13.719616,166889.786375791,942291.771074619,97.6636657714844,31,1.98973302134529,-0.468137860324438 +-151.06817,58.4457262,13.719616,170593.961595418,942291.782520642,73.919075012207,31,1.86875652369355,-0.907559029925762 +-151.0046,58.4442476,13.719616,174297.867978858,942291.782188554,71.3652877807617,31,1.8534870214259,-0.963022220511721 +-150.94104,58.4427372,13.719616,178001.512795043,942291.758009396,74.1737670898438,31,1.8702503362423,-0.902133076372143 +-150.87747,58.4411952,13.719616,181706.064759522,942291.786141982,79.5290069580078,31,1.90052555965193,-0.792164823539296 +-150.81392,58.4396215,13.719616,185409.786656353,942291.774140403,88.7346649169922,31,1.94809331364397,-0.619385163851482 +-150.75037,58.4380161,13.719616,189113.848216676,942291.776427161,77.3666076660156,31,1.88855355453849,-0.835650563261751 +-150.68683,58.436379,13.719616,192817.674698757,942291.764800992,79.0381774902344,31,1.89783691747203,-0.801930739351546 +-150.62329,58.4347103,13.719616,196521.853772377,942291.779189933,74.7408752441406,31,1.87355817929733,-0.890118046243848 +-150.55976,58.4330099,13.719616,200225.811239403,942291.779148281,78.6986846923828,31,1.89596747396499,-0.808721091761427 +-150.49624,58.4312778,13.719616,203929.553844046,942291.763884473,82.1331634521484,31,1.91451855049508,-0.741338286799745 +-150.43272,58.429514,13.719616,207633.669819417,942291.76388816,78.5641860961914,31,1.89522461569083,-0.811419365046023 +-150.36921,58.4277186,13.719616,211337.583805439,942291.759409085,76.0742492675781,31,1.88123767525226,-0.862223924989178 +-150.3057,58.4258916,13.719616,215041.884000001,942291.78208313,76.2177505493164,31,1.88205612708591,-0.859251074319965 +-150.2422,58.4240329,13.719616,218745.996250364,942291.788760127,77.4909973144531,31,1.88925125032873,-0.833116333009392 +-150.17871,58.4221425,13.719616,222449.927292613,942291.778729829,78.8252944946289,31,1.8966656019655,-0.806185291598014 +-150.11523,58.4202206,13.719616,226153.682554509,942291.773609659,82.0180587768555,31,1.91390948608684,-0.743550582574755 +-150.05175,58.4182669,13.719616,229857.852187092,942291.773864267,88.6025161743164,31,1.94744605535324,-0.621736190709309 +-149.98828,58.4162817,13.719616,233561.859438855,942291.778801348,96.0916442871094,131,1.98268562494461,-0.493736015578911 +-149.92482,58.4142648,13.719616,237265.712345487,942291.765464169,100.121643066406,131,2.00052796807181,-0.428927532629176 +-149.86136,58.4122164,13.719616,240969.997732835,942291.791814301,123.455665588379,131,2.09151102523036,-0.0984510998793422 +-149.79792,58.4101363,13.719616,244673.560694609,942291.762918532,145.592437744141,131,2.16313881775667,0.161721487183615 +-149.73448,58.4080246,13.719616,248377.570218035,942291.76245868,151.152206420898,131,2.17941449110647,0.22083937832978 +-149.67104,58.4058813,13.719616,252082.032992773,942291.791525236,158.601272583008,131,2.20030666768247,0.296725726874694 +-149.60762,58.4037064,13.719616,255785.792725603,942291.774193746,166.000900268555,131,2.22011044334491,0.368658692640987 +-149.5442,58.4014999,13.719616,259490.019083247,942291.786387102,167.287368774414,131,2.22346315029493,0.380836681241296 +-149.4808,58.3992619,13.719616,263193.555008704,942291.761130854,165.716400146484,131,2.21936549055977,0.365952811494676 +-149.4174,58.3969923,13.719616,266897.57090325,942291.765460738,158.824996948242,131,2.20091885566251,0.298949368354025 +-149.354,58.3946911,13.719616,270602.073446618,942291.800547738,157.140121459961,131,2.19628708449279,0.282125453426504 +-149.29062,58.3923583,13.719616,274305.906335527,942291.784970411,155.509918212891,131,2.19175809296263,0.265674863486081 +-149.22725,58.389994,13.719616,278009.656933621,942291.769593135,150.823501586914,131,2.17846901934719,0.217405155035544 +-149.16388,58.3875981,13.719616,281713.914185941,942291.785234228,148.427597045898,131,2.17151465653922,0.192144924344227 +-149.10053,58.3851707,13.719616,285417.520959172,942291.758318097,140.871841430664,131,2.14882419159463,0.109726679162011 +-149.03718,58.3827117,13.719616,289121.647705764,942291.762674068,121.268501281738,131,2.08374801029787,-0.126648585899235 +-148.97384,58.3802212,13.719616,292825.718757238,942291.7666189,120.500175476074,131,2.08098767934437,-0.136674895799209 +-148.91051,58.3776992,13.719616,296529.740746379,942291.769760036,122.294136047363,131,2.08740563329689,-0.113363055177221 +-148.84719,58.3751457,13.719616,300233.72030372,942291.771720844,121.502716064453,131,2.08458598623573,-0.123604818110756 +-148.78388,58.3725606,13.719616,303937.664934291,942291.761000635,123.733604431152,134,2.09248766435861,-0.0949036678049894 +-148.72058,58.3699441,13.719616,307641.579521104,942291.759535433,127.767486572266,134,2.10642035148487,-0.0442961713775855 +-148.65728,58.367296,13.719616,311346.053942398,942291.791598865,134.694259643555,134,2.12934908749544,0.0389875423256134 +-148.594,58.3646165,13.719616,315049.930053067,942291.785949764,146.972183227539,134,2.1672351455377,0.176600518892686 +-148.53073,58.3619055,13.719616,318753.796849822,942291.777475735,303.692321777344,330,2.48243381183303,1.32149204153362 +-136.27554,57.2104465,13.719616,1055849.85227076,942291.796584758,350.820343017578,351,2.54508476885626,1.54905819980546 +-136.21629,57.2016814,13.719616,1059553.65772214,942291.740672204,211.998687744141,250,2.32633317268704,0.754489964597084 +-136.15706,57.1928877,13.719616,1063257.98571255,942291.830572322,187.124694824219,150,2.27213110507447,0.557612584217881 +-136.09787,57.1840654,13.719616,1066961.67808786,942291.74548025,173.154373168945,150,2.23843346452052,0.435213135461748 +-136.0387,57.1752145,13.719616,1070665.9026499,942291.805011,153.798767089844,150,2.18695285400752,0.248220864049374 +-135.97956,57.1663351,13.719616,1074370.07973118,942291.858678215,126.13346862793,150,2.10083033884782,-0.0646006928238153 +-135.92046,57.1574271,13.719616,1078073.63562301,942291.732260157,89.2046508789062,50,1.95038749785582,-0.611052031968655 +-135.86138,57.1484906,13.719616,1081777.73509826,942291.75949603,56.934814453125,50,1.75537790965064,-1.31938251760791 +-135.80233,57.1395256,13.719616,1085481.80143482,942291.777492567,30.1353912353516,50,1.47907683410661,-2.32298688816235 +-135.56643,57.103381,8.565217348,1100297.81831713,942291.778007564,11.3108758926392,50,1.05349623716339,-3.86881708905614 +-135.50753,57.0942739,13.06094422,1104001.77796529,942291.776294298,166.836074829102,50,2.22228996359938,0.376575332302263 +-135.38982,57.0759744,9.822476255,1111409.68162196,942291.745966065,36.8308334350586,50,1.56621154649954,-2.00648874202824 +-153.93276,58.446265,13.719616,3913.69352320151,938587.781401995,83.1459426879883,20,1.91984106159872,-0.722005407275405 +-153.86912,58.4462155,13.719616,7617.85688991978,938587.774972426,72.6002044677734,20,1.8609378438282,-0.93595870687011 +-153.80548,58.4461343,13.719616,11322.0342388626,938587.775697441,105.542083740234,132,2.02342566429583,-0.345756564290333 +-153.74185,58.4460213,13.719616,15025.6503476645,938587.770181781,148.61653137207,132,2.17206712089393,0.194151632569565 +-153.67821,58.4458766,13.719616,18729.876073053,938587.773626522,124.454696655273,132,2.09501129060295,-0.0857371369708919 +-153.61458,58.4457001,13.719616,22433.5541656596,938587.769849271,136.910781860352,132,2.13643765060349,0.0647352268114056 +-153.55094,58.4454919,13.719616,26137.8554605258,938587.776314971,135.504684448242,132,2.1319543091946,0.0484504511412929 +-153.48731,58.4452519,13.719616,29841.6227293728,938587.77464344,141.695449829102,132,2.15135590426411,0.118922582200282 +-153.42367,58.4449801,13.719616,33546.026882429,938587.773388928,167.217895507812,132,2.22328275339251,0.38018142820133 +-153.36004,58.4446766,13.719616,37249.910529133,938587.77432272,177.793548583984,132,2.24991599811221,0.476920974908144 +-153.29641,58.4443414,13.719616,40953.8624988782,938587.78209609,175.779724121094,132,2.24496877852975,0.458951261307609 +-153.23278,58.4439743,13.719616,44657.8898307397,938587.774534816,177.547134399414,132,2.24931366720612,0.474733137134874 +-153.16915,58.4435755,13.719616,48361.9990899017,938587.774178618,175.453140258789,132,2.24416114561987,0.456017708057537 +-153.10553,58.443145,13.719616,52065.6150083605,938587.773394864,176.322189331055,132,2.2463069696881,0.463811953552502 +-153.0419,58.4426827,13.719616,55769.908623581,938587.776355622,183.118560791016,132,2.26273236636932,0.523473682573678 +-152.97828,58.4421887,13.719616,59473.7224787471,938587.778237671,207.091110229492,132,2.31616145639639,0.717543387732567 +-152.91466,58.4416629,13.719616,63177.645583674,938587.775964206,178.863037109375,132,2.25252060083562,0.486381635427197 +-152.85104,58.4411053,13.68070257,66881.6847489787,938587.769808997,13.2971448898315,35,1.12375840098954,-3.61360485522137 +-152.78742,58.4405161,12.23606549,70585.846376729,938587.78240855,26.6375484466553,35,1.42549425258977,-2.51761411822292 +-152.40577,58.4363137,13.719616,92809.7008743366,938587.770110767,132.767166137695,30,2.12309068551169,0.0162552399948567 +-152.34217,58.4355023,12.24437891,96513.7476548919,938587.77879437,44.6736869812012,30,1.65005179687552,-1.70195702227274 +-152.27857,58.4346591,12.53626402,100217.971637049,938587.784569348,44.0881500244141,30,1.64432187584958,-1.72276973092127 +-152.21498,58.4337841,13.719616,103921.797576913,938587.772226185,33.2671089172363,30,1.52201506008591,-2.1670229956157 +-152.15139,58.4328775,13.719616,107625.813704178,938587.779094122,76.7306976318359,30,1.88496914680336,-0.848670155247584 +-152.0878,58.4319391,13.719616,111330.027400816,938587.783302556,108.271774291992,30,2.03451525379134,-0.305476009958681 +-152.02422,58.430969,13.719616,115033.863088059,938587.779188124,93.953125,30,1.97291122986161,-0.529239408410469 +-151.96064,58.4299672,13.719616,118737.909583027,938587.783460569,77.9141845703125,30,1.89161652981415,-0.824524962800368 +-151.89707,58.4289336,13.719616,122441.5919593,938587.767033776,78.4204254150391,30,1.89442919393081,-0.814308563914387 +-151.83349,58.4278684,13.719616,126146.080383468,938587.789099348,131.054092407227,30,2.11745058714547,-0.00423120711560362 +-151.76993,58.4267714,13.719616,129849.636195279,938587.770887964,165.021102905273,132,2.21753948536109,0.359320239419294 +-151.70636,58.4256427,13.719616,133554.011950689,938587.781122392,188.271270751953,132,2.27478405392103,0.567248851655579 +-151.6428,58.4244823,13.719616,137258.050317363,938587.780725803,167.891738891602,132,2.22502932721573,0.386525482849038 +-151.57925,58.4232903,13.719616,140961.757651101,938587.779794546,191.323486328125,132,2.28176828605771,0.592617576274328 +-151.5157,58.4220665,13.719616,144665.723565887,938587.776722178,175.114242553711,132,2.24332146996087,0.45296776639675 +-151.45215,58.420811,13.719616,148369.954426029,938587.783311452,162.666534423828,132,2.21129821421527,0.336650161181543 +-151.38861,58.4195238,13.719616,152073.874943038,938587.777314811,152.004486083984,132,2.18185640539721,0.229709108025452 +-151.32507,58.418205,13.719616,155778.073473711,938587.792349108,121.749870300293,132,2.08546850723454,-0.120399249946519 +-151.26154,58.4168544,13.719616,159481.97561649,938587.782752126,104.309906005859,132,2.01832555405832,-0.364281620389361 +-151.19802,58.4154722,13.719616,163185.587216879,938587.769882106,105.832565307617,132,2.02461932324968,-0.34142085426578 +-151.13449,58.4140583,13.719616,166890.079576194,938587.79187649,109.112236022949,132,2.03787345580625,-0.293278061714244 +-151.07098,58.4126127,13.719616,170593.713303417,938587.774078885,70.7656936645508,31,1.84982276809888,-0.97633183447747 +-151.00747,58.4111354,13.719616,174297.65924729,938587.766382937,66.56884765625,31,1.82327103913789,-1.07277529268175 +-150.94396,58.4096265,13.719616,178001.92364475,938587.780717293,68.2975692749023,31,1.83440524732308,-1.03233267053372 +-150.88046,58.4080859,13.719616,181705.931689896,938587.779339381,76.7067031860352,31,1.88483331739753,-0.849163526419129 +-150.81697,58.4065137,13.719616,185409.689595559,938587.772536217,77.6596984863281,31,1.89019570006558,-0.82968582199238 +-150.75348,58.4049098,13.719616,189113.786670809,938587.776762626,75.8283462524414,31,1.87983158452051,-0.867331247865161 +-150.69,58.4032742,13.719616,192817.647612783,938587.763815594,73.1402893066406,31,1.86415667385859,-0.924266997454183 +-150.62652,58.4016071,13.719616,196521.860078776,938587.784781389,74.4073181152344,31,1.8716156514164,-0.897173861960053 +-150.56305,58.3999082,13.719616,200225.850433128,938587.776891698,74.9376678466797,31,1.87470017318428,-0.885969998488966 +-150.49959,58.3981777,13.719616,203929.624271215,938587.761673014,75.4518737792969,31,1.87767002955766,-0.875182632459455 +-150.43613,58.3964156,13.719616,207633.770348532,938587.769611405,73.9768218994141,31,1.86909566975857,-0.90632715461566 +-150.37268,58.3946219,13.719616,211337.713322552,938587.769794741,71.4569854736328,31,1.85404469085073,-0.960996605986046 +-150.30923,58.3927966,13.719616,215042.041945566,938587.793856965,67.6757965087891,31,1.83043337589192,-1.04675964125669 +-150.2458,58.3909396,13.719616,218745.599454945,938587.76570795,67.9188232421875,31,1.83199015273867,-1.04110498340094 +-150.18237,58.389051,13.719616,222449.556037824,938587.761110151,69.3943862915039,31,1.84132433931318,-1.00720055352021 +-150.11894,58.3871308,13.719616,226153.918393266,938587.78103885,69.3220443725586,31,1.84087136198517,-1.00884589646813 +-150.05553,58.385179,13.719616,229857.52912217,938587.757262791,71.0894088745117,31,1.85180490298045,-0.969132154829983 +-149.99212,58.3831956,13.719616,233561.55901654,938587.757781371,78.5798187255859,31,1.89531102261057,-0.81110551045054 +-149.92871,58.3811807,13.719616,237266.014085547,938587.794771847,88.12890625,31,1.94511838021474,-0.630190971196974 +-149.86532,58.3791341,13.719616,240969.738283326,938587.77439725,106.757141113281,131,2.02839693514778,-0.327699489614101 +-149.80193,58.3770559,13.719616,244673.901722471,938587.779206004,129.053482055664,131,2.11076972695164,-0.0284979982469378 +-149.73855,58.3749462,13.719616,248377.928326482,938587.784021616,145.466384887695,131,2.16276264593745,0.160355123766075 +-149.67518,58.3728049,13.719616,252081.825476995,938587.777106242,153.23762512207,131,2.18536541266387,0.242454823988365 +-149.61182,58.370632,13.719616,255785.599858451,938587.757890979,158.381057739258,131,2.19970323905121,0.294533901850277 +-149.54846,58.3684276,13.719616,259489.839453099,938587.77604555,164.552978515625,131,2.2163057477133,0.354838952138754 +-149.48511,58.3661917,13.719616,263193.968861327,938587.793073214,172.391860961914,131,2.23651675787634,0.428251109847548 +-149.42177,58.3639241,13.719616,266897.996269191,938587.786155359,166.196975708008,131,2.22062311664861,0.370520868411565 +-149.35844,58.3616251,13.719616,270601.926043988,938587.788230733,162.375717163086,131,2.21052108222909,0.333827395992194 +-149.29512,58.3592945,13.719616,274305.76637831,938587.776513528,161.972106933594,131,2.20944023153141,0.329901437752714 +-149.23181,58.3569324,13.719616,278009.52314286,938587.76167661,159.773391723633,131,2.20350445464139,0.308341001848756 +-149.1685,58.3545387,13.719616,281713.785836398,938587.77453595,154.816253662109,131,2.18981655392573,0.258622639533657 +-149.1052,58.3521135,13.719616,285417.978255904,938587.784490608,143.877960205078,131,2.15799427208532,0.14303502890576 +-149.04192,58.3496569,13.719616,289121.524153699,938587.75872143,125.97233581543,131,2.10027518224596,-0.0666171800592238 +-148.97864,58.3471687,13.719616,292825.595914342,938587.761042827,124.536727905273,131,2.0952974508237,-0.0846977213708981 +-148.91537,58.344649,13.719616,296529.617296359,938587.759226067,125.577239990234,131,2.09891093365,-0.0715725203550866 +-148.85211,58.3420979,13.719616,300233.594061773,938587.764032445,120.402366638184,131,2.08063502353146,-0.137955842369708 +-148.78886,58.3395152,13.719616,303937.534555655,938587.752816411,123.994369506836,134,2.09340196461683,-0.0915826682998595 +-148.72561,58.3369011,13.719616,307642.025707751,938587.793834673,131.446746826172,134,2.1187498422269,0.000488058184482808 +-148.66238,58.3342555,13.719616,311345.91090736,938587.783524852,139.361083984375,134,2.14414151572474,0.0927178638337956 +-148.59916,58.3315785,13.719616,315049.777913036,938587.778474416,157.204971313477,231,2.19646627567205,0.282776326935815 +-148.53595,58.32887,13.719616,318753.63422698,938587.767244388,352.699249267578,330,2.54740453525781,1.55748425350311 +-136.29173,57.1784392,13.719616,1055849.86280594,938587.791725139,606.443237304688,450,2.78279015742187,2.41247201894845 +-136.23253,57.1696817,13.719616,1059553.5999499,938587.725159146,250.160171508789,250,2.3982181659855,1.0155967782769 +-136.17335,57.1608955,13.719616,1063257.85928618,938587.790124726,199.276992797852,150,2.29945716082937,0.656868618352497 +-136.1142,57.1520808,13.719616,1066962.05768146,938587.847998637,180.223205566406,150,2.25581071006472,0.498332251237963 +-136.05509,57.1432375,13.719616,1070665.62085896,938587.725642134,134.836120605469,150,2.12980624886321,0.0406480829002179 +-135.996,57.1343657,13.719616,1074369.71474041,938587.754542834,129.773162841797,150,2.11318488942284,-0.0197254387955338 +-135.93694,57.1254654,13.719616,1078073.76205751,938587.772896486,98.0524139404297,150,1.99145828997834,-0.461871192208507 +-135.87791,57.1165365,13.719616,1081777.77059249,938587.768819571,46.1426048278809,50,1.66410210753322,-1.65092228360605 +-135.81891,57.1075792,9.972620073,1085481.73910637,938587.762688354,14.8973703384399,50,1.17310961416428,-3.43434716273208 +-135.5832,57.0714655,9.928728723,1100297.90485798,938587.807294268,19.5276069641113,50,1.29064902536881,-3.00741047214918 +-135.52435,57.0623661,13.719616,1104001.74726182,938587.764065886,47.3108100891113,50,1.67496038440914,-1.61148192273194 +-135.46553,57.0532383,13.69467126,1107705.57797474,938587.712188706,46.3381004333496,50,1.66593822651431,-1.64425297538621 +-135.40673,57.0440822,13.38233366,1111409.98065828,938587.828675366,25.8512554168701,50,1.41248163862455,-2.56487964631441 +-135.34797,57.0348978,11.54985523,1115113.79587912,938587.778310929,14.0210313796997,50,1.14677996127953,-3.52998397724062 +-135.28924,57.0256851,11.50215451,1118817.61034258,938587.726833572,105.34391784668,50,2.02260946617215,-0.348721228841694 +-153.9964,58.4131369,12.42212561,209.738142856934,934883.780798041,38.0628623962402,20,1.58050144491129,-1.9545837522537 +-153.93282,58.4131192,13.64054062,3913.94812331105,934883.77681605,64.8421936035156,20,1.81185769855445,-1.11423180337254 +-153.86925,58.4130698,13.719616,7617.58267246372,934883.775603238,108.979187011719,132,2.03734356372921,-0.295202780984318 +-153.80567,58.4129887,13.719616,11321.8137812152,934883.778921637,165.45458984375,132,2.21867881934214,0.363458625636759 +-153.74209,58.4128758,13.719616,15026.0656659426,934883.775049402,185.779525756836,132,2.26899784991175,0.546231707146835 +-153.67852,58.4127312,13.719616,18729.7624775371,934883.772399561,155.179794311523,132,2.19083517188166,0.262322550692104 +-153.61494,58.4125549,13.719616,22434.076206628,934883.776130049,147.520065307617,132,2.16885109597319,0.182470112112546 +-153.55137,58.4123469,13.719616,26137.8484198937,934883.78013408,160.021438598633,132,2.20417817041447,0.310788129834219 +-153.4878,58.4121071,13.719616,29841.6685878724,934883.776165571,189.727340698242,132,2.27812991949589,0.579401990428567 +-153.42423,58.4118356,13.719616,33545.5434239716,934883.775523558,210.27180480957,132,2.32278104236513,0.741587613388981 +-153.36065,58.4115324,13.719616,37250.0623121073,934883.783957999,173.322311401367,132,2.23885447208958,0.436742355120091 +-153.29708,58.4111974,13.719616,40954.0669363506,934883.779791992,174.217315673828,132,2.24109131788098,0.444867217493792 +-153.23352,58.4108307,13.719616,44657.5639772217,934883.772700556,177.699783325195,132,2.24968689825702,0.476088818842487 +-153.16995,58.4104323,13.719616,48361.7254237157,934883.775765248,185.588562011719,132,2.2685512067521,0.544609371706323 +-153.10638,58.4100022,13.719616,52065.9754466106,934883.783026183,193.325134277344,132,2.286288320497,0.609035631504085 +-153.04282,58.4095403,13.719616,55769.738377367,934883.775135418,199.380249023438,132,2.29968213409107,0.657685785452762 +-152.97926,58.4090467,13.719616,59473.6034582151,934883.770788771,188.164474487305,132,2.27453763189414,0.566353776518043 +-152.9157,58.4085214,13.6122267,63177.5774646626,934883.77024247,44.1009101867676,35,1.64444755284678,-1.72231323619562 +-152.85214,58.4079644,8.95106609,66881.6671717501,934883.773769167,26.368803024292,35,1.42109041603752,-2.53361010956081 +-152.40729,58.4031773,13.719616,92810.0268294211,934883.785174726,127.876182556152,30,2.10678966294885,-0.0429547267284172 +-152.21669,58.40065,13.24366521,103921.681505849,934883.769534023,42.3269004821777,30,1.62661646708559,-1.78708082917886 +-152.15316,58.3997442,12.78992039,107625.743499121,934883.772409546,37.9237976074219,30,1.57891182015778,-1.9603577230825 +-152.08963,58.3988067,13.39749543,111330.002467912,934883.78056626,72.0604553222656,30,1.8576970019348,-0.947730369655328 +-152.02611,58.3978375,13.719616,115033.882572593,934883.777168914,122.275184631348,30,2.08733832726363,-0.113607529901086 +-151.96259,58.3968366,13.719616,118737.973184576,934883.778926169,43.4583015441895,30,1.63807274903466,-1.74546834319141 +-151.89908,58.395804,13.719616,122441.698462463,934883.767920099,71.8132858276367,30,1.85620479839078,-0.953150478844488 +-151.83557,58.3947398,13.719616,126145.647411699,934883.773176281,61.9681739807129,30,1.79216869896097,-1.18574786969604 +-151.77206,58.3936438,13.719616,129849.827512531,934883.772908814,118.167922973633,30,2.072499602043,-0.16750601529627 +-151.70856,58.3925162,13.719616,133553.662181741,934883.769912689,142.044036865234,132,2.15242300637375,0.122798601643787 +-151.64506,58.3913569,13.719616,137257.741150076,934883.772598456,161.906219482422,132,2.20926353210739,0.329259615009633 +-151.58156,58.3901659,13.719616,140962.071177152,934883.781567032,169.314788818359,132,2.22869489326371,0.399839864992031 +-151.51807,58.3889433,13.719616,144666.075998033,934883.78681903,156.692077636719,132,2.19504703906186,0.277621254477158 +-151.45459,58.387689,13.719616,148369.762766327,934883.776147286,150.656600952148,132,2.17798816484635,0.215658554238954 +-151.39111,58.386403,13.719616,152073.720844293,934883.771427403,131.255905151367,132,2.11811885125486,-0.00180388112872909 +-151.32763,58.3850854,13.719616,155777.956537535,934883.784491167,117.563926696777,132,2.07027408330618,-0.1755897345747 +-151.26416,58.3837361,13.719616,159481.894422251,934883.780840484,110.082527160645,132,2.04171839108879,-0.279312159314269 +-151.2007,58.3823552,13.719616,163185.540780303,934883.770665675,106.758018493652,132,2.02840050436932,-0.3276865251827 +-151.13723,58.3809426,13.719616,166890.068024623,934883.792102906,114.958778381348,132,2.06054214008565,-0.210938930124814 +-151.07378,58.3794983,13.719616,170593.735087572,934883.770494275,84.4158096313477,31,1.9264237901407,-0.698095058313141 +-151.01033,58.3780224,13.719616,174297.713427085,934883.766894982,61.1099472045898,31,1.78611190851503,-1.20774786137581 +-150.94688,58.3765149,13.719616,178002.009758744,934883.782067722,65.6131744384766,31,1.81699104991647,-1.09558600602135 +-150.88344,58.3749758,13.719616,181706.048190825,934883.789430635,68.5063552856445,31,1.8357308625502,-1.02751765766056 +-150.82001,58.373405,13.719616,185409.835971042,934883.776944039,70.0896606445312,31,1.84565395725043,-0.991474145376141 +-150.75658,58.3718026,13.719616,189113.961903224,934883.783385068,65.6167907714844,31,1.81701498581354,-1.09549906401117 +-150.69316,58.3701686,13.719616,192817.850091414,934883.780547333,63.3836555480957,31,1.80197728279661,-1.15012029355644 +-150.62975,58.3685029,13.719616,196521.507810965,934883.756441491,66.7973709106445,31,1.82475936933978,-1.06736925257676 +-150.56634,58.3668057,13.719616,200225.523251825,934883.76272439,69.3979721069336,31,1.84134678002782,-1.00711904243942 +-150.50293,58.3650768,13.719616,203929.904263819,934883.777952833,67.4769439697266,31,1.82915540516874,-1.05140159569243 +-150.43953,58.3633164,13.719616,207634.073779285,934883.794072686,66.1381301879883,31,1.82045191267448,-1.08301516465564 +-150.37614,58.3615243,13.719616,211338.039687528,934883.788002138,66.0150680541992,31,1.81964307532821,-1.08595309276249 +-150.31276,58.3597007,13.719616,215041.807481036,934883.78130878,58.904483795166,31,1.77014835443707,-1.26573204623892 +-150.24938,58.3578454,13.719616,218745.96769441,934883.783883729,58.9560813903809,31,1.77052860973752,-1.26435085045202 +-150.18601,58.3559586,13.719616,222449.943168289,934883.785501775,62.4397621154785,31,1.79546123980787,-1.17378842155537 +-150.12265,58.3540402,13.719616,226153.741218509,934883.774305823,63.0584945678711,31,1.7997435983708,-1.15823367294798 +-150.05929,58.3520902,13.719616,229857.951145031,934883.784223433,64.433967590332,31,1.80911487431601,-1.12419452388652 +-149.99594,58.3501087,13.719616,233561.996360851,934883.792244926,68.2460021972656,31,1.83407721579309,-1.03352417468016 +-149.9326,58.3480956,13.719616,237265.884208481,934883.786563423,78.0110549926758,31,1.89215615117914,-0.822564903979457 +-149.86927,58.3460509,13.719616,240969.621376591,934883.766543439,83.8641357421875,31,1.92357627573655,-0.708438043390559 +-149.80594,58.3439747,13.719616,244673.796452749,934883.779559783,102.254661560059,131,2.00968311563942,-0.395673423524342 +-149.74262,58.3418669,13.719616,248377.834199919,934883.778128979,114.352058410645,131,2.0582439865933,-0.219286479567325 +-149.67931,58.3397276,13.719616,252081.740574701,934883.772814261,138.814468383789,131,2.14243473421516,0.0865183462270565 +-149.61601,58.3375568,13.719616,255785.522226362,934883.763042295,143.192031860352,131,2.15591885166345,0.13549650954954 +-149.55271,58.3353544,13.719616,259489.769155912,934883.776179889,152.255111694336,131,2.18257188221379,0.23230792404071 +-149.48942,58.3331205,13.719616,263193.904676275,934883.784878468,158.432403564453,131,2.1998440109026,0.295045225394809 +-149.42614,58.3308551,13.719616,266897.935430813,934883.78861267,168.20068359375,131,2.22582775650583,0.389425605925106 +-149.36287,58.3285581,13.719616,270601.868840451,934883.77572624,167.16015625,131,2.22313276842086,0.379636639974329 +-149.29961,58.3262297,13.719616,274305.709995902,934883.768020222,165.08854675293,131,2.21771694452542,0.359964821756032 +-149.23635,58.3238698,13.719616,278010.048909295,934883.795731522,160.550659179688,131,2.20561209300755,0.315996545974544 +-149.17311,58.3214784,13.719616,281713.727003821,934883.775232339,155.693267822266,131,2.19226983407839,0.267533653283956 +-149.10987,58.3190555,13.719616,285417.916124342,934883.79035879,140.318054199219,131,2.14711355367019,0.103513153955762 +-149.04664,58.3166011,13.719616,289122.040295701,934883.798819162,126.538558959961,131,2.10222288434076,-0.059542570121385 +-148.98343,58.3141152,13.719616,292825.523540545,934883.756106742,126.620903015137,131,2.1025054064299,-0.0585163692537918 +-148.92022,58.3115979,13.719616,296529.536843304,934883.760592993,127.686561584473,131,2.10614519219829,-0.0452956284447194 +-148.85702,58.3090491,13.719616,300233.50505482,934883.75721776,128.519012451172,131,2.10896737974398,-0.0350446377462545 +-148.79382,58.3064688,13.719616,303938.017402912,934883.791380987,124.999435424805,134,2.09690805146849,-0.0788475601178085 +-148.73064,58.3038571,13.719616,307641.914409587,934883.782896508,134.826248168945,134,2.12977444950814,0.0405325785661608 +-148.66747,58.301214,13.719616,311345.785266244,934883.776635647,144.628601074219,134,2.16025418549268,0.151243679444791 +-148.60431,58.2985394,13.719616,315049.637462837,934883.761140096,235.19401550293,330,2.37142626694866,0.918280953805772 +-148.54115,58.2958334,13.719616,318754.059300393,934883.795240157,366.490020751953,430,2.56406215362554,1.61798947797235 +-136.24874,57.1376788,13.67449962,1059553.60548276,934883.72488091,668.144287109375,450,2.82487025937497,2.56531896009898 +-136.18961,57.1289002,13.719616,1063257.78838886,934883.776194025,216.63069152832,250,2.33571998607107,0.78858555007114 +-136.13051,57.120093,13.719616,1066961.90946021,934883.806128036,191.814346313477,150,2.28288108610771,0.596659583680671 +-136.07144,57.1112573,13.719616,1070665.97053993,934883.824278477,145.574111938477,150,2.16308414941447,0.161522916160864 +-136.0124,57.1023931,13.719616,1074369.97641348,934883.8294845,123.061996459961,150,2.09012395645745,-0.103489329571417 +-135.95339,57.0935003,13.719616,1078073.93485633,934883.8098426,97.0019149780273,50,1.98678030804131,-0.478862957832792 +-135.89441,57.0845791,13.719616,1081777.84465966,934883.785718537,44.8068656921387,50,1.65134456542125,-1.69726131792177 +-135.59994,57.0395466,10.44176661,1100298.01021993,934883.835966646,12.3619327545166,50,1.09208637682078,-3.72864668709803 +-135.54114,57.030455,13.719616,1104001.72754597,934883.762462764,68.5599670410156,50,1.83607060013585,-1.02628363377874 +-135.48236,57.021335,13.719616,1107706.01188688,934883.84348793,29.6366329193115,150,1.47182886099326,-2.34931359528753 +-135.42362,57.0121866,13.719616,1111409.70272802,934883.744934535,107.368469238281,50,2.03087676137914,-0.318692052928919 +-135.3649,57.00301,13.04990891,1115113.96379087,934883.821334516,59.1700477600098,50,1.77210191982459,-1.25863613914836 +-153.93289,58.3799727,13.58751114,3913.61285822739,931179.780181256,35.9115943908691,20,1.55523468721421,-2.04635982806012 +-153.86937,58.3799233,13.719616,7617.87712270261,931179.774738042,198.873870849609,132,2.29857772685866,0.653674263155424 +-153.80586,58.3798423,13.719616,11321.5721372986,931179.779488233,207.320739746094,132,2.31664274978679,0.719291582701317 +-153.74234,58.3797295,13.719616,15025.8710594952,931179.774976828,221.496719360352,132,2.34536729816971,0.82362734123043 +-153.67883,58.3795851,13.719616,18729.6142612598,931179.779643791,173.699996948242,132,2.23979981081692,0.440176095204334 +-153.61531,58.3794089,13.719616,22433.9749426156,931179.776298116,168.199996948242,132,2.22582598358222,0.3894191661605 +-153.5518,58.3792011,13.719616,26137.7934325115,931179.781181485,173.275131225586,132,2.23873623642132,0.436312889425141 +-153.48829,58.3789615,13.719616,29841.6598097051,931179.774873492,173.042327880859,132,2.23815234888949,0.43419204325146 +-153.42478,58.3786902,13.719616,33545.5807841912,931179.768672665,173.407730102539,132,2.23906845338269,0.437519596253012 +-153.36127,58.3783873,13.719616,37249.5630229819,931179.773893642,171.435119628906,132,2.23409979482563,0.419472010177411 +-153.29776,58.3780527,13.719616,40953.6133863998,931179.779519368,175.67529296875,132,2.24471068647057,0.458013797281827 +-153.23425,58.3776863,13.719616,44657.7387772233,931179.774549652,180.98112487793,132,2.2576332832183,0.504952357145921 +-153.17074,58.3772883,13.719616,48361.9457220592,931179.781522029,194.000411987305,132,2.28780265221694,0.614536116544229 +-153.10724,58.3768585,13.719616,52065.6580988487,931179.77045565,199.665008544922,132,2.30030196107809,0.659937173985861 +-153.04373,58.3763971,13.719616,55770.0487181127,931179.779042532,186.130462646484,132,2.26981745683094,0.54920875341644 +-152.98023,58.375904,13.719616,59473.9581644731,931179.780110691,55.9060363769531,35,1.74745870276418,-1.34814733738622 +-152.91673,58.3753792,13.71541094,63177.9763736584,931179.78175575,52.6258964538574,35,1.72119950687978,-1.44352823195905 +-152.85324,58.3748227,10.73006872,66881.5269535462,931179.77417891,78.8169021606445,35,1.89661936124543,-0.806353251091714 +-152.4723,58.3708183,9.975767543,89105.635025964,931179.77394145,81.5269393920898,30,1.91130113875386,-0.753024844584597 +-152.40882,58.37004,11.50140222,92809.6004419056,931179.770691979,78.7512435913086,30,1.89625742062772,-0.807667922723386 +-152.21839,58.3675151,10.7962624,103921.957982175,931179.777641665,67.7385482788086,30,1.83083588493839,-1.04529761351236 +-152.028,58.3647052,13.719616,115033.691390836,931179.769802651,89.7838897705078,30,1.95319841671804,-0.600841972344953 +-151.96454,58.3637053,13.64096058,118737.81909487,931179.78003659,26.0263538360596,30,1.41541332985356,-2.55423090698265 +-151.90109,58.3626737,13.719616,122441.580582162,931179.774267746,56.7472763061523,30,1.75394502157273,-1.32458717609384 +-151.83764,58.3616104,13.719616,126145.565776582,931179.770351871,37.4017753601074,30,1.57289221746247,-1.98222263823754 +-151.77419,58.3605155,13.719616,129849.781062911,931179.780007658,55.8707885742188,30,1.74718480114386,-1.34914222625053 +-151.71075,58.3593889,13.719616,133553.650388804,931179.772523157,69.6362380981445,30,1.84283530154141,-1.00171230743573 +-151.64731,58.3582307,13.719616,137257.763279393,931179.778643659,124.119087219238,132,2.09383857309078,-0.0899967817020061 +-151.58388,58.3570408,13.719616,140961.543701617,931179.766575121,129.923736572266,132,2.11368850227103,-0.0178961731854894 +-151.52045,58.3558193,13.719616,144665.58115716,931179.768210149,129.536575317383,132,2.11239241101011,-0.0226039465864149 +-151.45702,58.3545662,13.719616,148369.882368043,931179.784179835,129.565689086914,132,2.11249000914988,-0.0222494422854879 +-151.3936,58.3532814,13.719616,152073.871329898,931179.781066962,128.975250244141,132,2.11050637918573,-0.0294545524996337 +-151.33019,58.351965,13.719616,155777.554345348,931179.769028451,120.876022338867,132,2.08234016025963,-0.131762299078518 +-151.26678,58.3506169,13.719616,159481.521756394,931179.759920512,102.858184814453,30,2.01223885585886,-0.386390245566458 +-151.20337,58.3492373,13.719616,163185.779371525,931179.77676927,111.395126342773,30,2.04686619040018,-0.260613882887107 +-151.13997,58.347826,13.719616,166889.75167332,931179.772828207,115.10595703125,132,2.0610978000751,-0.208920614441979 +-151.07657,58.3463831,13.719616,170594.028080543,931179.784005063,115.602874755859,132,2.06296863404198,-0.202125211485096 +-151.01318,58.3449086,13.719616,174298.032143043,931179.784799391,65.1263885498047,31,1.81375699593275,-1.1073330131811 +-150.9498,58.3434025,13.719616,178001.770573026,931179.774299046,56.851203918457,31,1.7547396660265,-1.32170080062363 +-150.88642,58.3418648,13.719616,181705.833245045,931179.778968901,62.9119415283203,31,1.7987330881738,-1.16190413441183 +-150.82305,58.3402955,13.719616,185409.643704882,931179.771683918,69.2473373413086,31,1.8404030788165,-1.01054683459806 +-150.75968,58.3386946,13.719616,189113.791824294,931179.780056837,62.4953231811523,31,1.79584751826223,-1.1723853479543 +-150.69632,58.3370621,13.719616,192817.70114622,931179.775879572,62.2756156921387,31,1.7943180299119,-1.17794088620213 +-150.63296,58.335398,13.719616,196521.961539507,931179.787912707,64.4470825195312,31,1.80920326188574,-1.12387347500495 +-150.56961,58.3337023,13.719616,200225.99654413,931179.786865009,63.0358200073242,31,1.79958740676669,-1.15880100543562 +-150.50627,58.331975,13.719616,203929.81286223,931179.771937712,62.5208473205566,31,1.79602485521005,-1.17174120954281 +-150.44293,58.3302162,13.719616,207633.999759873,931179.784771178,59.7653160095215,31,1.77644922018151,-1.24284550340899 +-150.3796,58.3284258,13.719616,211337.981349305,931179.783290226,51.0348129272461,31,1.70786652716391,-1.4919574198984 +-150.31628,58.3266039,13.719616,215041.763708439,931179.777901365,54.4432754516602,31,1.73594424562369,-1.38997113227374 +-150.25296,58.3247504,13.719616,218745.937294951,931179.789650442,57.0278167724609,31,1.75608674556683,-1.31680782323839 +-150.18965,58.3228653,13.719616,222449.925639249,931179.785996646,56.7845458984375,31,1.75423015711516,-1.32355148241795 +-150.12635,58.3209487,13.719616,226153.734782351,931179.77739299,56.2795677185059,31,1.750350752974,-1.33764258555083 +-150.06305,58.3190005,13.719616,229857.955208762,931179.78660865,57.4005889892578,31,1.75891634873024,-1.30652989689972 +-149.99976,58.3170208,13.719616,233562.009771081,931179.790631633,62.6724548339844,31,1.79707670602873,-1.16792058714123 +-149.93648,58.3150095,13.719616,237265.905807864,931179.777653171,66.510856628418,31,1.82289254137797,-1.07415010457981 +-149.87321,58.3129668,13.719616,240969.648616658,931179.76934034,74.3124465942383,31,1.87106155985059,-0.899186480680552 +-149.80994,58.3108925,13.719616,244673.829389994,931179.779606381,79.9477462768555,31,1.90280622551413,-0.783880794160908 +-149.74668,58.3087867,13.719616,248377.870930699,931179.783269866,89.2999420166016,31,1.95085117689663,-0.609367817345277 +-149.68343,58.3066494,13.719616,252081.779886692,931179.779739126,107.083229064941,31,2.02972145874147,-0.322888441865141 +-149.62019,58.3044805,13.719616,255785.56364036,931179.757288926,109.955924987793,131,2.04121863633596,-0.281127411220767 +-149.55695,58.3022802,13.719616,259489.810537321,931179.776732727,130.889389038086,131,2.1169044405233,-0.00621496753308554 +-149.49372,58.3000484,13.719616,263193.944781751,931179.788418743,137.0439453125,131,2.13685985289663,0.0662687860486091 +-149.4305,58.2977851,13.719616,266897.973013764,931179.791819163,147.7294921875,131,2.16946720496465,0.184707995824558 +-149.36729,58.2954903,13.719616,270601.901871456,931179.786422172,155.349060058594,131,2.19130862989482,0.264042285334249 +-149.30409,58.293164,13.719616,274305.737990864,931179.771731884,155.439483642578,131,2.1915613449029,0.264960218375643 +-149.24089,58.2908063,13.719616,278010.070369607,931179.800275397,150.097900390625,131,2.17637461725897,0.209797688849276 +-149.17771,58.2884171,13.719616,281713.740091005,931179.77727575,145.123397827148,131,2.16173743813048,0.156631276387715 +-149.11453,58.2859964,13.719616,285417.920112166,931179.786566487,133.358169555664,131,2.12501962583217,0.0232617018132365 +-149.05136,58.2835443,13.719616,289122.033065138,931179.79699602,123.93953704834,131,2.09320986959543,-0.0922804122469486 +-148.98821,58.2810607,13.719616,292825.503222265,931179.75291067,126.283866882324,131,2.10134787176266,-0.0627208655585283 +-148.92506,58.2785457,13.719616,296529.502681078,931179.752679023,127.921333312988,131,2.10694297737557,-0.042397844970267 +-148.86191,58.2759993,13.719616,300234.038030736,931179.79758707,136.235687255859,134,2.13429088693173,0.056937568408218 +-148.79878,58.2734214,13.719616,303937.950404967,931179.786264909,130.669631958008,134,2.11617466787519,-0.00886571008885859 +-148.73566,58.2708121,13.719616,307641.82869904,931179.774148641,148.611221313477,134,2.1720516033043,0.194095268254875 +-148.67255,58.2681715,13.719616,311345.67859988,931179.772036011,277.655609130859,231,2.44350645140835,1.1800967574963 +-148.60945,58.2654994,13.719616,315049.508467613,931179.757326717,360.058502197266,330,2.55637307053747,1.59006053351366 +-148.54635,58.2627959,13.719616,318753.907158727,931179.788847959,434.551452636719,430,2.63804120603958,1.88670251206394 +-136.20584,57.0969016,13.71612125,1063257.78343824,931179.768701776,425.3193359375,351,2.6287151271299,1.85282753153605 +-136.14679,57.088102,13.719616,1066961.81941208,931179.781978549,210.324249267578,150,2.32288934741753,0.741981008252623 +-136.08777,57.0792739,13.719616,1070665.79153436,931179.779935847,152.297210693359,150,2.18269194935328,0.232744042161885 +-136.02878,57.0704172,13.719616,1074369.70757378,931179.750650164,124.303901672363,150,2.09448476056589,-0.0876496443521312 +-135.96982,57.0615321,13.719616,1078073.56635165,931179.714476733,93.8664245605469,50,1.97251027559252,-0.530695788759553 +-135.91088,57.0526185,13.719616,1081777.95877899,931179.822399698,52.6258544921875,50,1.72119916059154,-1.44352948977677 +-135.5579,56.9985405,13.69280607,1104001.72634821,931179.76222084,25.4578285217285,50,1.40582135684906,-2.58907169075667 +-135.49917,56.9894282,13.719616,1107705.88057227,931179.799130636,114.037002563477,50,2.05704579345634,-0.223638659039121 +-135.44047,56.9802877,13.71150326,1111410.01386545,931179.841649336,53.7989311218262,50,1.73077364718118,-1.40875222165266 +-153.99641,58.346843,13.719616,209.555993216686,927475.779131642,25.5936050415039,20,1.40813146366603,-2.58068072342732 +-153.93295,58.3468253,13.719616,3913.85351911339,927475.771385614,105.780090332031,20,2.02440393355351,-0.342203211120614 +-153.8695,58.346776,13.719616,7617.5744688973,927475.771141323,238.575286865234,132,2.37762545469927,0.94079817314033 +-153.80604,58.3466951,13.719616,11321.8930254257,927475.780160625,201.72673034668,132,2.30476344939223,0.676142572978354 +-153.74259,58.3465824,13.719616,15025.6485724064,927475.77328527,185.424850463867,132,2.26816793744657,0.543217228192699 +-153.67913,58.3464381,13.719616,18730.0152486405,927475.776889225,172.757904052734,132,2.23743792642516,0.43159705694454 +-153.61568,58.3462621,13.719616,22433.8324156632,927475.774790254,171.38395690918,132,2.23397016559236,0.419001159802299 +-153.55223,58.3460545,13.719616,26137.6904911886,927475.780516041,179.030426025391,132,2.25292684512531,0.487857230641017 +-153.48878,58.3458151,13.719616,29841.5963866646,927475.771826159,168.459289550781,132,2.22649496479416,0.391849096868537 +-153.42533,58.3455441,13.719616,33545.5567119745,927475.771192439,168.988906860352,132,2.22785819664054,0.396800744039687 +-153.36188,58.3452415,13.719616,37249.5782060984,927475.778754955,170.186874389648,132,2.23092606221178,0.407944107450438 +-153.29843,58.3449071,13.719616,40953.6678438397,927475.772323033,175.83772277832,132,2.24511205069808,0.459471666716925 +-153.23498,58.3445411,13.719616,44657.832170242,927475.774417092,185.928924560547,132,2.26934695728068,0.547499764755929 +-153.17153,58.3441434,13.719616,48362.0780628073,927475.77405304,223.56916809082,132,2.34941191079184,0.838318528721381 +-153.10809,58.3437141,13.719616,52065.8284198188,927475.774770058,183.402816772461,132,2.26340600145037,0.525920517462646 +-153.04465,58.3432531,13.719616,55769.6738608343,927475.772341537,54.3611297607422,35,1.73528847388381,-1.39235308240886 +-152.98121,58.3427605,13.719616,59473.6209834367,927475.778179067,49.8209075927734,35,1.69741163486133,-1.52993257286472 +-152.91777,58.3422361,8.802618558,63177.6768883437,927475.770191886,21.3859367370605,35,1.33012827777855,-2.86401055889649 +-152.85433,58.3416802,10.59728033,66881.8477973936,927475.78216961,28.304027557373,35,1.45184823840374,-2.42188891957017 +-152.09328,58.3325395,11.81260331,111329.924342489,927475.777395685,103.868705749512,30,2.01648472015123,-0.370968054566231 +-152.02988,58.3315721,11.9484522,115033.873232531,927475.775475219,54.5920715332031,30,1.73712957421748,-1.38566568049462 +-151.90309,58.3295424,13.719616,122441.823065409,927475.772072535,54.0240631103516,30,1.73258724405074,-1.40216472017033 +-151.8397,58.3284802,13.70965182,126145.837116578,927475.781691681,26.1345176696777,30,1.4172144893073,-2.54768858174461 +-151.77631,58.3273863,13.719616,129850.081281325,927475.790466571,51.6532783508301,30,1.71309789070544,-1.47295561433574 +-151.71293,58.3262607,13.719616,133553.978593017,927475.778852784,55.0096168518066,30,1.74043862005019,-1.37364628153451 +-151.64956,58.3251036,13.719616,137257.535014653,927475.768093318,76.9426193237305,132,1.88616696671839,-0.844319331424357 +-151.58618,58.3239148,13.719616,140961.925489998,927475.777229017,93.0097579956055,132,1.96852851437473,-0.545158682010356 +-151.52281,58.3226945,13.719616,144665.98849446,927475.787313503,80.8810729980469,30,1.90784690413141,-0.765571610670048 +-151.45945,58.3214425,13.719616,148369.731569406,927475.774970373,72.761100769043,30,1.86189926068151,-0.932466566443207 +-151.39609,58.3201589,13.719616,152073.744747709,927475.773237944,69.5874938964844,30,1.84253119622305,-1.00281690475231 +-151.33273,58.3188437,13.719616,155778.034745704,927475.782778432,95.9555053710938,30,1.98206989708812,-0.495972514899891 +-151.26938,58.3174969,13.719616,159482.024557127,927475.780255914,81.9846343994141,30,1.91373246432453,-0.744193576142506 +-151.20604,58.3161186,13.719616,163185.720425971,927475.775855951,78.0082702636719,30,1.89214064806838,-0.822621215702768 +-151.1427,58.3147086,13.719616,166889.713715646,927475.771417401,103.643707275391,30,2.01554293905375,-0.374388872323376 +-151.07936,58.3132671,13.719616,170594.01018704,927475.78999506,136.411087036133,132,2.13484966975545,0.0589672271164654 +-151.01603,58.3117939,13.719616,174298.03380074,927475.783760125,106.602149963379,132,2.02776596367569,-0.329991358097897 +-150.95271,58.3102892,13.719616,178001.790272429,927475.77412467,60.7925071716309,31,1.78385005469142,-1.21596356006051 +-150.88939,58.3087529,13.719616,181705.870522276,927475.776388778,63.6435775756836,31,1.80375458451489,-1.14366462642322 +-150.82608,58.3071851,13.719616,185409.697001133,927475.77458691,67.721809387207,31,1.83072855304561,-1.04568747358253 +-150.76277,58.3055856,13.719616,189113.861192133,927475.774007293,64.2644195556641,31,1.80797058929263,-1.12835089370292 +-150.69947,58.3039547,13.719616,192817.78444373,927475.779921934,64.0347518920898,31,1.80641573115322,-1.13399858226596 +-150.63617,58.3022921,13.719616,196522.058812534,927475.787607843,66.1731185913086,31,1.82068160245501,-1.08218086581277 +-150.57289,58.300598,13.719616,200225.522435166,927475.759942089,63.4306678771973,31,1.8022992842156,-1.14895069249432 +-150.5096,58.2988724,13.719616,203929.933142801,927475.786570789,59.5199928283691,31,1.7746628702092,-1.24933403638347 +-150.44633,58.2971152,13.719616,207633.547034128,927475.765101477,59.8234481811523,31,1.77687144184288,-1.24131187382083 +-150.38306,58.2953264,13.719616,211337.538247668,927475.756737904,55.6807441711426,31,1.74570503097142,-1.35451717388528 +-150.31979,58.2935062,13.719616,215041.91223971,927475.784714271,57.3227767944336,31,1.75832722005906,-1.30866978038753 +-150.25654,58.2916544,13.719616,218745.509455086,927475.761775609,56.1179084777832,31,1.74910147644249,-1.34218031449229 +-150.19329,58.2897711,13.719616,222449.503387288,927475.763675763,58.1954727172852,31,1.76488920027914,-1.28483479525258 +-150.13004,58.2878562,13.719616,226153.901344281,927475.780227263,57.1473503112793,31,1.75699609874062,-1.31350479295595 +-150.06681,58.2859099,13.719616,229857.541247815,927475.765500876,63.8822326660156,31,1.80538008620136,-1.13776034033361 +-150.00358,58.283932,13.719616,233561.598506643,927475.76517884,60.1944465637207,31,1.77955642584281,-1.23155924556234 +-149.94035,58.2819226,13.719616,237266.079121996,927475.791431317,62.0860366821289,31,1.79299393715281,-1.18275036903684 +-149.87714,58.2798817,13.719616,240969.822301213,927475.772720476,63.224781036377,31,1.80088733394593,-1.15407929888447 +-149.81393,58.2778094,13.719616,244674.001431688,927475.791583407,70.4938278198242,31,1.84815109342916,-0.982403834021337 +-149.75073,58.2757055,13.719616,248378.040835586,927475.789379749,72.4423904418945,31,1.85999277265521,-0.939391475120584 +-149.68754,58.2735702,13.719616,252081.945739265,927475.7878178,80.2419128417969,31,1.90440127303748,-0.778087126284234 +-149.62436,58.2714034,13.719616,255785.723489313,927475.775168149,85.1497802734375,31,1.93018353161563,-0.684438604139145 +-149.56118,58.2692051,13.719616,259489.964447966,927475.789942053,101.143898010254,31,2.00493968700388,-0.412902910237931 +-149.49802,58.2669753,13.719616,263193.50781122,927475.754004604,101.828681945801,131,2.00787012236554,-0.402258732574862 +-149.43486,58.2647141,13.719616,266897.526891316,927475.756677109,120.034423828125,131,2.07930581216997,-0.142783917429322 +-149.3717,58.2624214,13.719616,270602.029069372,927475.787969886,132.924057006836,131,2.12360358801439,0.0181182482816179 +-149.30856,58.2600973,13.719616,274305.852746663,927475.777594959,139.10871887207,131,2.14335435097955,0.089858656800089 +-149.24543,58.2577418,13.719616,278009.588243564,927475.765256332,125.999160766602,131,2.10036765245369,-0.0662813018711281 +-149.1823,58.2553548,13.719616,281713.826688213,927475.781760683,123.325630187988,131,2.09105334336359,-0.100113531054891 +-149.11918,58.2529363,13.719616,285417.990985688,927475.785353044,121.231056213379,131,2.08361388892577,-0.127135753004747 +-149.05608,58.2504865,13.719616,289121.502376852,927475.75434829,126.042816162109,131,2.10051809800879,-0.0657348406735634 +-148.99298,58.2480052,13.719616,292825.536546451,927475.752551808,125.269218444824,131,2.09784436786671,-0.0754465917081812 +-148.92989,58.2454926,13.719616,296529.514688624,927475.758864607,126.55729675293,131,2.10228718978015,-0.0593089944109342 +-148.8668,58.2429485,13.719616,300234.028804599,927475.795822651,136.027740478516,134,2.13362748416595,0.054527900208884 +-148.80373,58.240373,13.719616,303937.917193636,927475.784334387,155.251174926758,134,2.19103489556216,0.263048004106466 +-148.74067,58.2377661,13.719616,307641.77015861,927475.768692069,337.262664794922,231,2.52796826715721,1.48688618009853 +-148.67762,58.2351279,13.719616,311345.593384152,927475.759690483,443.770477294922,330,2.64715840656119,1.91981878666654 +-148.61457,58.2324583,13.719616,315049.978041859,927475.793302835,465.430023193359,430,2.66785439460746,1.9949925224737 +-136.16304,57.0561078,13.719616,1066961.79203666,927475.776996603,451.338745117188,351,2.65450261707505,1.94649505549927 +-136.10407,57.0472872,13.719616,1070665.67335959,927475.744522191,159.96208190918,150,2.20401704784824,0.310202886684679 +-136.04512,57.0384381,13.719616,1074370.0754977,927475.853796569,128.589279174805,150,2.10920476182841,-0.0341823982600198 +-135.98621,57.0295606,13.719616,1078073.83279639,927475.791413414,99.6835021972656,50,1.99862328772429,-0.435845875301272 +-135.92733,57.0206546,13.719616,1081777.53672127,927475.70667614,63.6564826965332,50,1.80384263824842,-1.14334479013002 +-135.86847,57.0117202,10.30998177,1085481.77275119,927475.772634741,22.3087158203125,50,1.34847457126081,-2.79737158441543 +-135.75085,56.9937662,10.70436675,1092889.52516417,927475.700502873,24.4558906555176,50,1.38838348395276,-2.65241102238049 +-135.69208,56.9847467,13.68224286,1096593.63167781,927475.734896007,39.8121337890625,50,1.60001545485064,-1.88370329830098 +-135.63334,56.9756988,13.719616,1100297.70545016,927475.753121275,58.0524864196777,50,1.76382082554264,-1.28871543724003 +-135.57463,56.9666226,13.719616,1104001.74813305,927475.764804569,74.2201614379883,50,1.87052189465776,-0.901146698696718 +-135.51595,56.9575181,13.719616,1107705.76440078,927475.7688391,118.863975524902,150,2.07505025157972,-0.158241328151028 +-135.4573,56.9483853,13.51551608,1111409.75892166,927475.764127303,65.991340637207,50,1.81948695129631,-1.08652017980857 +-135.39868,56.9392243,10.70437438,1115113.73327291,927475.760306024,16.0899620056152,50,1.20655501856944,-3.31286390766372 +-154.24999,58.3134489,10.17019671,-14606.4638929617,923771.780480788,40.8135604858398,20,1.61080448332763,-1.84451446737727 +-154.1232,58.3136351,12.57262049,-7198.32761446493,923771.771764261,29.8919334411621,20,1.47555400656392,-2.33578280331251 +-154.0598,58.3136808,13.719616,-3493.99036998779,923771.774488139,90.3359451293945,20,1.95586059267378,-0.591172189413047 +-153.99641,58.3136948,13.719616,209.756221744597,923771.771424109,112.145950317383,20,2.04978359547076,-0.25001703496044 +-153.93302,58.3136772,13.719616,3913.50319720642,923771.772655015,239.370574951172,121,2.37907076293859,0.94604794519761 +-153.86962,58.313628,13.719616,7617.84157214782,923771.77933696,232.676559448242,132,2.36675263332948,0.901304982513088 +-153.80623,58.3135471,13.719616,11321.609557383,923771.778585115,204.264465332031,132,2.31019282158845,0.695863602492151 +-153.74283,58.3134345,13.719616,15025.9824797378,923771.773293201,184.875640869141,132,2.26687969248405,0.538537954787095 +-153.67944,58.3132903,13.719616,18729.7984953394,923771.770725907,178.465850830078,132,2.25155512680735,0.48287475818281 +-153.61605,58.3131145,13.719616,22433.6486196414,923771.772662538,177.484588623047,132,2.2491606482838,0.47417732873305 +-153.55266,58.3129071,13.719616,26137.5395887848,923771.779193887,169.433807373047,132,2.22900007004822,0.400948354179505 +-153.48926,58.3126679,13.719616,29842.0625897647,923771.772573316,168.164611816406,132,2.22573460912037,0.389087268034217 +-153.42587,58.3123972,13.719616,33546.0555742052,923771.778016125,168.576965332031,132,2.22679823154239,0.392950648259061 +-153.36249,58.3120948,13.719616,37249.5254601677,923771.771641786,173.192764282227,132,2.23852974392877,0.435562849753371 +-153.2991,58.3117608,13.719616,40953.6474553226,923771.775440256,178.706619262695,132,2.2521406389971,0.485001505577781 +-153.23571,58.3113951,13.719616,44657.8441440728,923771.773359593,196.277465820312,132,2.29287044207758,0.632943775809297 +-153.17233,58.3109978,13.719616,48361.537874649,923771.769479857,222.155899047852,132,2.34665784982949,0.828314993218886 +-153.10894,58.3105689,13.719616,52065.903939697,923771.77801279,84.4023971557617,132,1.9263547814211,-0.698345717679783 +-153.04556,58.3101083,11.80086991,55769.7806754024,923771.772884998,37.3383331298828,35,1.57215492612907,-1.98490069080436 +-152.98218,58.3096161,13.02367199,59473.7589552087,923771.772789506,75.5545120239258,35,1.87826040498982,-0.873038220379916 +-152.0951,58.2994047,8.3005273,111329.872204316,923771.779086734,29.6202297210693,30,1.47158842238931,-2.35018693692511 +-151.90509,58.2964104,13.719616,122441.842213416,923771.777466259,67.4474639892578,30,1.82896562493191,-1.05209093168125 +-151.84176,58.2953491,13.719616,126145.87915426,923771.778095972,29.3013763427734,30,1.46688802049176,-2.36726013824529 +-151.77844,58.2942562,13.719616,129849.561245996,923771.766244682,34.2991180419922,30,1.5352829528585,-2.11883022203202 +-151.71511,58.2931317,13.719616,133554.063766368,923771.781023015,37.7421531677246,30,1.57682667278141,-1.9679315735138 +-151.6518,58.2919757,13.719616,137257.64020127,923771.773847,46.3293991088867,30,1.66585666745144,-1.64454922118183 +-151.58848,58.290788,13.719616,140962.05088494,923771.783309184,76.524658203125,30,1.8838013985003,-0.852911750392838 +-151.52518,58.2895688,13.719616,144665.548895522,923771.768677963,75.0616989135742,30,1.87541838981914,-0.883361230671691 +-151.46187,58.288318,13.719616,148369.89418074,923771.783091923,106.725967407227,30,2.02827010011422,-0.328160190658294 +-151.39857,58.2870356,13.719616,152073.924896352,923771.783071151,140.308547973633,130,2.14708413022077,0.103406279589185 +-151.33528,58.2857216,13.719616,155777.647755301,923771.76760327,77.2867050170898,30,1.88810479231021,-0.83728059576437 +-151.27199,58.2843761,13.719616,159481.653289662,923771.770870699,117.442192077637,130,2.06982414882486,-0.177224025034917 +-151.2087,58.282999,13.719616,163185.948647572,923771.782401493,112.236915588379,130,2.05013572322564,-0.24873800644744 +-151.14542,58.2815903,13.719616,166889.956259196,923771.77777521,101.923042297363,30,2.00827237842571,-0.400797623749002 +-151.08215,58.2801501,13.719616,170593.682341822,923771.767207091,93.2476196289062,132,1.96963775420485,-0.541129606338815 +-151.01888,58.2786784,13.719616,174297.717849493,923771.776009512,136.805526733398,132,2.13610364256929,0.0635220142958067 +-150.95561,58.2771751,13.719616,178002.069967795,923771.793776997,86.9402236938477,31,1.93922075327923,-0.651612835577058 +-150.89236,58.2756402,13.719616,181705.57684251,923771.766561983,66.9318923950195,31,1.82563310417721,-1.06419559825847 +-150.8291,58.2740738,13.719616,185409.997480569,923771.786724658,67.3440093994141,31,1.82829896901979,-1.05451241623662 +-150.76586,58.2724759,13.719616,189113.585713912,923771.771314253,65.9541549682617,31,1.81924216035165,-1.08740933038986 +-150.70262,58.2708464,13.719616,192817.517323443,923771.764713315,67.3673400878906,31,1.82844940013646,-1.05396600748356 +-150.63938,58.2691854,13.719616,196521.79844242,923771.778919662,66.9063186645508,31,1.82546713468207,-1.0647984468372 +-150.57615,58.2674928,13.719616,200225.852032552,923771.773478136,67.3467788696289,31,1.82831682867668,-1.05444754486515 +-150.51293,58.2657688,13.719616,203929.683616421,923771.769902597,67.9022369384766,31,1.83188408170369,-1.04149026367567 +-150.44971,58.2640132,13.719616,207633.885297447,923771.77635302,72.6185913085938,31,1.86104781999909,-0.935559242027103 +-150.3865,58.2622262,13.719616,211337.878273448,923771.784223641,65.3581085205078,31,1.81529947511872,-1.10173028851027 +-150.3233,58.2604076,13.719616,215041.670407997,923771.77044388,66.2593154907227,31,1.8212469449758,-1.08012738041245 +-150.2601,58.2585575,13.719616,218745.85204045,923771.778369508,65.0285568237305,31,1.81310411583405,-1.1097044600501 +-150.19691,58.2566759,13.719616,222449.845547227,923771.775453924,65.3131561279297,31,1.81500067068199,-1.10281563151176 +-150.13373,58.2547629,13.719616,226153.656932114,923771.772143701,71.9945602416992,31,1.85729968328874,-0.949173544383828 +-150.07055,58.2528183,13.719616,229857.878416112,923771.780048591,77.1372222900391,31,1.88726399587526,-0.840334608403293 +-150.00738,58.2508423,13.719616,233561.931059664,923771.787305149,70.7606658935547,31,1.84979191118703,-0.976443915588755 +-149.94422,58.2488348,13.719616,237265.822161602,923771.782098854,70.817268371582,31,1.85013917074138,-0.975182569769627 +-149.88107,58.2467958,13.719616,240969.558368838,923771.763785706,73.9426956176758,31,1.86889527894662,-0.907055031241919 +-149.81792,58.2447253,13.719616,244673.730605635,923771.768579965,63.5746002197266,31,1.80328363785423,-1.1453752391163 +-149.75478,58.2426234,13.719616,248377.760522318,923771.77129324,63.7654037475586,31,1.80458511388216,-1.14064790670463 +-149.69165,58.2404901,13.719616,252081.654728468,923771.771327282,63.7149200439453,31,1.80424114244564,-1.1418973091413 +-149.62852,58.2383253,13.719616,255786.004845883,923771.795466113,73.7051086425781,31,1.8674975906866,-0.91213183394225 +-149.56541,58.236129,13.719616,259489.648953776,923771.766672053,86.5331268310547,31,1.93718239701144,-0.659016727346497 +-149.5023,58.2339013,13.719616,263193.76148994,923771.773133165,96.7287673950195,131,1.98555565363758,-0.483311252178277 +-149.4392,58.2316422,13.719616,266897.764777034,923771.775799163,102.723983764648,131,2.0116718535349,-0.388449759845653 +-149.37611,58.2293516,13.719616,270601.666192203,923771.76300495,112.549674987793,131,2.05134424521649,-0.24434830963017 +-149.31302,58.2270297,13.719616,274306.055068371,923771.797844794,118.966690063477,131,2.07542537864735,-0.156878759569467 +-149.24995,58.2246763,13.719616,278009.771008154,923771.775489096,121.742904663086,131,2.08544365936952,-0.120489504484556 +-149.18688,58.2222915,13.719616,281713.988386219,923771.789778832,123.688148498535,131,2.09232808856793,-0.095483292624203 +-149.12383,58.2198753,13.719616,285417.545235769,923771.755976642,136.084548950195,131,2.13380881817468,0.055186557086493 +-149.06078,58.2174277,13.719616,289121.616704529,923771.759039829,129.418472290039,131,2.11199626892212,-0.0240428477202136 +-148.99774,58.2149488,13.719616,292825.624259767,923771.767266028,128.666091918945,131,2.1094641099755,-0.0332403717644464 +-148.93471,58.2124384,13.719616,296529.576157523,923771.757963201,134.253356933594,134,2.12792515380927,0.0338154087463318 +-148.87168,58.2098967,13.719616,300234.061567618,923771.798229196,195.664138793945,134,2.2915112357191,0.628006750359178 +-148.80867,58.2073236,13.719616,303937.919353071,923771.786686613,325.009979248047,231,2.51189669595064,1.42850964619313 +-148.74567,58.2047191,13.719616,307641.740371334,923771.767624974,516.556701660156,330,2.71311800033102,2.159402857981 +-148.68268,58.2020833,13.719616,311345.530304745,923771.751836065,600.212097167969,430,2.77830474430501,2.39617971824367 +-136.12034,57.0152973,13.719616,1070665.61753855,923771.730240424,411.264404296875,351,2.61412112213638,1.79981793985585 +-136.06144,57.0064557,13.719616,1074369.9207763,923771.806063126,123.117828369141,150,2.09032094652764,-0.102773805409913 +-136.00258,56.9975858,13.719616,1078073.57179333,923771.717433767,105.446357727051,150,2.02303158316169,-0.347187979451513 +-135.94374,56.9886874,13.719616,1081777.74985771,923771.765780417,82.3862991333008,50,1.91585499439689,-0.73648394108928 +-135.88493,56.9797606,13.719616,1085481.87245004,923771.798921572,68.7262573242188,50,1.83712269386254,-1.02246212906593 +-135.82615,56.9708054,13.719616,1089185.94430238,923771.815704723,67.1103210449219,50,1.82678931641582,-1.05999590539199 +-135.7674,56.9618219,13.719616,1092889.96711522,923771.825729192,80.7627029418945,50,1.90721084535216,-0.767881957705523 +-135.70868,56.95281,13.719616,1096593.94861546,923771.81711337,92.6436080932617,50,1.9668154607236,-0.551380981825465 +-135.64999,56.9437698,13.719616,1100297.89047279,923771.799469777,105.074020385742,50,2.02149534973101,-0.352768017756401 +-135.59133,56.9347013,13.719616,1104001.79736716,923771.771675085,132.698608398438,150,2.1228663684707,0.015440456475542 +-135.5327,56.9256046,13.719616,1107705.67090911,923771.743346472,120.884910583496,50,2.08237209358774,-0.131646308116136 +-135.4741,56.9164796,13.719616,1111409.51881127,923771.702642305,44.1378211975098,50,1.64481089100839,-1.72099348828563 +-135.41552,56.9073263,13.04112219,1115113.93001492,923771.816377828,26.076114654541,50,1.41624288192962,-2.55121773706466 +-154.31308,58.2801597,11.07150515,-18310.2095069354,920067.776786386,13.142484664917,20,1.11867747894168,-3.63206021433872 +-154.05975,58.2805319,13.719616,-3494.40145742978,920067.77739331,80.1199569702148,20,1.90374070737637,-0.780486489309605 +-153.99641,58.2805459,13.719616,209.956449639481,920067.775426854,191.813613891602,121,2.28287942779908,0.596653560230396 +-153.93308,58.2805283,13.719616,3913.72990333466,920067.775046736,257.912963867188,121,2.41147317228328,1.0637427445059 +-153.86975,58.2804791,13.719616,7617.51047368404,920067.775735896,219.472869873047,132,2.3413808426071,0.809147396779335 +-153.80641,58.2803983,13.719616,11321.8897306942,920067.779224484,199.90983581543,132,2.30083416247869,0.661870281378252 +-153.74308,58.2802858,13.719616,15025.7047768095,920067.771528751,188.673141479492,132,2.27571008067655,0.570612445145958 +-153.67975,58.2801418,13.719616,18729.5471060841,920067.776200984,182.285919189453,132,2.26075312255238,0.516284504098128 +-153.61641,58.2799661,13.719616,22434.008385366,920067.774346352,175.815093994141,132,2.2450561571824,0.459268645514361 +-153.55308,58.2797589,13.719616,26137.9255551059,920067.782204194,172.334945678711,132,2.23637335160112,0.427730217323696 +-153.48975,58.27952,13.719616,29841.8903244526,920067.780354804,171.122543334961,132,2.23330722637957,0.416593175359773 +-153.42642,58.2792495,13.719616,33545.9093611738,920067.780094864,172.20686340332,132,2.23605045651827,0.426557370219358 +-153.36309,58.2789474,13.719616,37249.9893973483,920067.781563927,175.248977661133,132,2.24365549312986,0.454181033886218 +-153.29977,58.2786137,13.719616,40953.5523278858,920067.778751071,188.655349731445,132,2.27566912507321,0.570463682704764 +-153.23644,58.2782483,13.719616,44657.7746865898,920067.772431161,230.537155151367,132,2.3627409296251,0.886733329604535 +-153.17311,58.2778514,13.719616,48362.078121483,920067.779529633,114.384239196777,132,2.05836618790616,-0.218842609519295 +-153.10979,58.2774229,12.51510103,52065.884644341,920067.781238167,48.0244598388672,35,1.68146248877957,-1.58786442377318 +-151.90709,58.2632775,13.719616,122441.638698053,920067.769171885,47.3254432678223,30,1.67509469041962,-1.61099408496712 +-151.78055,58.2611253,12.007969,129849.973384653,920067.778227905,22.5153217315674,30,1.35247815717264,-2.78282941764647 +-151.71729,58.2600019,13.719616,133553.905872513,920067.780094811,29.4910182952881,30,1.46968976856365,-2.35708338954966 +-151.65403,58.2588469,13.719616,137258.080869719,920067.785799605,35.9655456542969,30,1.555886653622,-2.04399169997729 +-151.59078,58.2576604,13.719616,140961.919848072,920067.785877446,64.3873901367188,30,1.80880082185882,-1.12533525205056 +-151.52753,58.2564422,13.719616,144666.015157247,920067.778716794,77.4998626708984,30,1.88930093294084,-0.832935871581385 +-151.46429,58.2551926,13.719616,148369.787424483,920067.776100799,139.63200378418,30,2.1449849703925,0.0957815319330466 +-151.40105,58.2539114,13.719616,152073.829007888,920067.777566083,150.715438842773,130,2.17815774243269,0.216274508434817 +-151.33782,58.2525987,13.719616,155777.561332315,920067.771479965,123.678634643555,130,2.09229468218516,-0.0956046341415717 +-151.27459,58.2512544,13.719616,159481.576369567,920067.76969382,125.00904083252,130,2.09694142294158,-0.0787263454023732 +-151.21136,58.2498786,13.719616,163185.880357768,920067.784062949,131.942642211914,130,2.12038517677767,0.00642806004382159 +-151.14814,58.2484712,13.719616,166889.895613735,920067.779000989,134.351028442383,130,2.12824099525852,0.0349626350401258 +-151.08493,58.2470323,13.719616,170593.628351851,920067.764721402,122.170783996582,30,2.08696736084846,-0.11495498580535 +-151.02172,58.2455619,13.719616,174297.670080537,920067.76653501,108.118431091309,130,2.0338997350166,-0.307711749835094 +-150.95851,58.24406,13.719616,178002.027469997,920067.785196654,129.29264831543,132,2.11157383124689,-0.0255772619323698 +-150.89532,58.2425266,13.719616,181705.53751528,920067.766755694,83.7624816894531,31,1.92304953600685,-0.710351312435287 +-150.83212,58.2409616,13.719616,185409.961927382,920067.781247584,89.3188781738281,31,1.95094325978704,-0.609033346004219 +-150.76894,58.2393652,13.719616,189113.551806751,920067.768041657,73.9158325195312,31,1.8687374727576,-0.907628228362794 +-150.70575,58.2377372,13.719616,192818.069404952,920067.789391806,72.6458358764648,31,1.86121072520385,-0.934967523825663 +-150.64258,58.2360777,13.719616,196521.766341713,920067.770191886,76.3029327392578,31,1.88254123058921,-0.85748903993366 +-150.57941,58.2343868,13.719616,200225.818377349,920067.77940412,75.1764221191406,31,1.87608165243805,-0.880952071525827 +-150.51625,58.2326643,13.719616,203929.648475057,920067.764871048,76.8727798461914,31,1.8857725861562,-0.845751834193628 +-150.45309,58.2309104,13.719616,207633.846969353,920067.779384038,78.8410110473633,31,1.89675218498178,-0.805870797369636 +-150.38994,58.229125,13.719616,211337.83625571,920067.780861223,78.0411682128906,31,1.89232376180673,-0.821956094339222 +-150.3268,58.2273081,13.719616,215041.622989674,920067.768544677,83.9133529663086,31,1.92383107475193,-0.707512540639794 +-150.26366,58.2254597,13.719616,218745.79866208,920067.774630613,83.6371536254883,31,1.9223992443061,-0.712713357504146 +-150.20053,58.2235799,13.719616,222449.78444941,920067.777725374,87.7226028442383,31,1.94311150928136,-0.637480499245018 +-150.13741,58.2216686,13.719616,226153.587619947,920067.765962818,93.1137390136719,31,1.96901376624022,-0.543396108730247 +-150.07429,58.2197258,13.719616,229857.799659501,920067.773260324,94.4028625488281,31,1.9749851634751,-0.521706289566698 +-150.01118,58.2177516,13.719616,233561.84170765,920067.776596962,95.9061508178711,31,1.98184646098296,-0.496784098608845 +-149.94808,58.215746,13.719616,237265.72037801,920067.775308696,98.3450012207031,31,1.9927522900567,-0.457171014579497 +-149.88498,58.2137089,13.719616,240970.027811206,920067.793880277,97.9205780029297,31,1.99087396835073,-0.463993615141984 +-149.8219,58.2116403,13.719616,244673.60097524,920067.759670013,81.1003952026367,31,1.90902297053552,-0.761299801807534 +-149.75882,58.2095404,13.719616,248377.614757776,920067.767491132,83.1952896118164,31,1.92009873790723,-0.72106945337475 +-149.69574,58.207409,13.719616,252082.077180669,920067.79611505,75.7565994262695,31,1.87942047175614,-0.868824526768613 +-149.63268,58.2052462,13.719616,255785.824472085,920067.780750237,69.3110046386719,31,1.84080219383872,-1.00909713491862 +-149.56962,58.203052,13.719616,259490.032908359,920067.797301274,83.2146148681641,31,1.92019960753103,-0.720703066110045 +-149.50658,58.2008263,13.719616,263193.540171654,920067.756478909,95.7209625244141,131,1.98100705702184,-0.499833053385382 +-149.44354,58.1985693,13.719616,266897.521034183,920067.758745928,101.45719909668,131,2.00628286868859,-0.408024090976845 +-149.3805,58.1962809,13.719616,270601.982837366,920067.794106038,107.929466247559,131,2.03314002931381,-0.310471217789197 +-149.31748,58.193961,13.719616,274305.763289107,920067.769973269,115.646385192871,131,2.06313206239566,-0.201531593057409 +-149.25446,58.1916098,13.719616,278010.037092049,920067.790199765,122.003311157227,131,2.08637161754195,-0.117118895536672 +-149.19146,58.1892272,13.719616,281713.641939385,920067.759999398,122.075263977051,131,2.0866276720809,-0.116188832365951 +-149.12846,58.1868133,13.719616,285417.753274416,920067.774338493,129.172012329102,131,2.11116842536389,-0.0270498118137637 +-149.06547,58.184368,13.719616,289121.793644139,920067.779768223,132.21240234375,131,2.12127219657786,0.00964996913876893 +-149.00249,58.1818913,13.719616,292825.769632597,920067.775861857,130.830230712891,131,2.11670810725143,-0.00692810601559606 +-148.93952,58.1793833,13.719616,296529.686971091,920067.773348819,143.270202636719,134,2.15615587514212,0.136357446477331 +-148.87656,58.1768439,13.719616,300233.553068664,920067.760691777,230.560394287109,134,2.36278470616843,0.886892338504971 +-148.8136,58.1742732,13.719616,303937.958467952,920067.794416039,386.664276123047,231,2.58733404949921,1.70251964624591 +-148.75066,58.1716711,13.719616,307641.740920794,920067.772042746,684.796691894531,330,2.83556165369097,2.60415315588246 +-136.07773,56.9744701,13.719616,1074369.82808962,920067.781424908,181.193115234375,250,2.25814169183679,0.506799042362565 +-136.01891,56.9656077,13.719616,1078073.95583304,920067.818649468,142.809387207031,150,2.15475675560698,0.131275444977199 +-135.96012,56.9567169,13.719616,1081778.01951274,920067.838268069,123.258598327637,150,2.09081722471192,-0.100971181392711 +-135.90136,56.9477977,13.719616,1085482.02386629,920067.839111552,121.387702941895,150,2.08417469320564,-0.125098751790775 +-135.84263,56.9388502,13.719616,1089185.97061199,920067.830765765,125.013000488281,150,2.09695517898196,-0.0786763795373623 +-135.78393,56.9298743,13.719616,1092889.86747006,920067.801329393,125.933670043945,150,2.10014186004693,-0.0671014443400743 +-135.72526,56.92087,13.719616,1096593.71916035,920067.749661536,138.082794189453,150,2.14013956667344,0.0781816426095168 +-135.66662,56.9118375,13.719616,1100297.52431322,920067.696105159,121.952507019043,150,2.08619073268046,-0.117775920983275 +-135.608,56.9027767,13.719616,1104001.87546809,920067.79502455,134.330612182617,150,2.1281749939571,0.0347228994747238 +-135.54942,56.8936877,13.719616,1107705.60456419,920067.72411252,101.126113891602,50,2.00486331834653,-0.413180302999232 +-135.49086,56.8845704,13.71818519,1111409.88898488,920067.804552846,72.2698211669922,50,1.85895698004962,-0.943153769508749 +-135.43234,56.8754249,12.96304035,1115113.56063868,920067.711820181,30.1370544433594,50,1.47910080267308,-2.32289982748763 +-135.19853,56.838561,1.675773192,1129929.81181043,920067.776348107,32.9072570800781,50,1.51729168403757,-2.18417964560902 +-135.14015,56.8292747,3.825523974,1133633.99168378,920067.829171341,66.8959274291992,50,1.82539967907032,-1.06504346487285 +-154.12296,58.2473366,13.49148237,-7198.02077198009,916363.779555594,82.9900665283203,20,1.91902611273618,-0.724965534153695 +-154.05969,58.2473822,13.719616,-3494.22157142047,916363.781356424,166.055892944336,121,2.22025429232703,0.369181193202643 +-153.99642,58.2473962,13.719616,209.571282803646,916363.780984512,268.897125244141,121,2.42958615924346,1.12953428310646 +-153.93314,58.2473786,13.719616,3913.94991500799,916363.779021951,237.874801635742,121,2.37634843913622,0.936159688118809 +-153.86987,58.2473294,13.719616,7617.75026557145,916363.77485689,208.088027954102,132,2.31824709442096,0.725119020338158 +-153.8066,58.2472487,13.719616,11321.5644262297,916363.779719645,198.225067138672,132,2.29715857361863,0.648519493520988 +-153.74332,58.2471363,13.719616,15025.9845756428,916363.77356759,189.989608764648,132,2.27872984842871,0.581581103549329 +-153.68005,58.2469924,13.719616,18729.846578283,916363.774837944,183.731018066406,132,2.26418248149856,0.528740914627134 +-153.61678,58.2468169,13.719616,22433.7425907086,916363.774136298,179.128112792969,132,2.25316375040924,0.488717738251768 +-153.55351,58.2466098,13.719616,26137.6793421473,916363.771553071,176.876083374023,132,2.24766911294989,0.468759646673713 +-153.49024,58.2463712,13.719616,29841.663475889,916363.778368016,178.718292236328,132,2.25216900583933,0.485104542045487 +-153.42697,58.2461009,13.719616,33545.7018816692,916363.772357882,177.770095825195,132,2.24985870651954,0.47671287549091 +-153.3637,58.2457991,13.719616,37249.8011059361,916363.776007929,184.555404663086,132,2.26612676793312,0.535803117912034 +-153.30043,58.2454657,13.719616,40953.9679628151,916363.778300578,219.126663208008,132,2.34069522548209,0.806657039686672 +-153.23717,58.2451007,13.719616,44657.6237857353,916363.772683119,170.406188964844,132,2.23148536381372,0.409975650509267 +-153.1739,58.2447041,13.719616,48361.9460917397,916363.772234742,78.3893051147461,35,1.89425681464256,-0.814934694691265 +-153.11064,58.244276,12.02241367,52065.7706693253,916363.774325455,53.5428810119629,35,1.72870173580749,-1.4162779951443 +-152.28841,58.2358373,10.81855528,100217.75239435,916363.769678898,61.9221611022949,30,1.79184610494912,-1.18691962322459 +-151.97229,58.2311716,8.964930861,118737.957282171,916363.784040786,12.0614681243896,30,1.08140017343558,-3.76746202793917 +-151.90908,58.2301438,13.11502516,122441.79752811,916363.777851868,46.7171745300293,30,1.66947656862653,-1.63140070689125 +-151.78267,58.2279936,9.496672431,129849.564824691,916363.768816764,15.687403678894,30,1.1955510722528,-3.35283338152474 +-151.71947,58.2268712,13.719616,133553.505258949,916363.765959807,28.9189720153809,30,1.46118285100208,-2.38798294224929 +-151.65627,58.2257173,13.719616,137257.687471419,916363.774841008,43.421989440918,30,1.63770971740075,-1.74678697770531 +-151.59308,58.2245318,13.719616,140961.533150987,916363.763661216,65.570182800293,30,1.81670639441911,-1.0966199560365 +-151.52989,58.2233149,13.719616,144665.633570819,916363.775471146,86.5038528442383,30,1.93703545118422,-0.659550476533473 +-151.4667,58.2220664,13.719616,148369.996227784,916363.788564047,141.118377685547,130,2.14958357511297,0.11248497685024 +-151.40352,58.2207863,13.719616,152074.042434529,916363.780682957,161.396789550781,130,2.20789489163607,0.324288322168902 +-151.34035,58.2194748,13.719616,155777.778002497,916363.773141147,166.90380859375,130,2.22246624699906,0.37721564392619 +-151.27718,58.2181318,13.719616,159481.795425555,916363.777787572,136.804382324219,130,2.13610000958251,0.0635088182508501 +-151.21402,58.2167572,13.719616,163185.516449553,916363.759575795,156.506851196289,130,2.19453335384167,0.275755403137086 +-151.15086,58.2153512,13.719616,166889.532213284,916363.764994535,148.027282714844,130,2.17034176702015,0.187884654834989 +-151.0877,58.2139137,13.719616,170593.849844153,916363.783601137,139.72900390625,130,2.14528656308649,0.0968770026807297 +-151.02455,58.2124446,13.719616,174297.891116102,916363.778725612,96.5187683105469,31,1.9846117711797,-0.486739702676178 +-150.96141,58.2109441,13.719616,178001.661705742,916363.771772246,154.492446899414,130,2.18890725172143,0.255319794386953 +-150.89827,58.2094121,13.719616,181705.754163046,916363.778035532,91.7094879150391,31,1.96241426845073,-0.567367368385882 +-150.83514,58.2078486,13.719616,185409.589757521,916363.770382281,98.7308120727539,31,1.99445270915285,-0.450994607074349 +-150.77201,58.2062536,13.719616,189113.760546568,916363.776416912,108.109115600586,31,2.03386231456503,-0.307847671596058 +-150.70889,58.2046271,13.719616,192817.687796876,916363.767922861,85.0270462036133,31,1.92955709216895,-0.686714011013106 +-150.64577,58.2029692,13.719616,196521.962998901,916363.784810844,94.6763916015625,31,1.97624169732007,-0.517142199991307 +-150.58266,58.2012798,13.719616,200226.007959277,916363.786620965,95.5812759399414,130,1.98037282373632,-0.502136769706586 +-150.51956,58.1995589,13.719616,203929.829334911,916363.772545438,96.1657562255859,130,1.98302045114565,-0.492519831247819 +-150.45646,58.1978066,13.719616,207634.01857994,916363.784214527,91.7286605834961,31,1.96250505201143,-0.567037616581206 +-150.39337,58.1960229,13.719616,211337.996921735,916363.79070121,90.7283782958984,31,1.95774314824709,-0.584334210235929 +-150.33029,58.1942077,13.719616,215041.77159781,916363.780087951,109.497611999512,31,2.03940464788167,-0.287716335050571 +-150.26721,58.192361,13.719616,218745.934653419,916363.78456908,111.631195068359,31,2.047785574108,-0.257274418842068 +-150.20414,58.1904829,13.719616,222449.906704623,916363.782748632,118.22908782959,31,2.07272433889505,-0.16668970690333 +-150.14108,58.1885734,13.719616,226153.69436694,916363.773912799,119.179130554199,31,2.07620021279802,-0.154064340774553 +-150.07802,58.1866324,13.719616,229857.890308285,916363.780821591,127.602516174316,130,2.10585923825542,-0.046334294784617 +-150.01497,58.18466,13.719616,233561.915107852,916363.780451772,134.553131103516,130,2.1288938084183,0.0373338387678477 +-149.95193,58.1826562,13.719616,237265.775375997,916363.772137179,136.747100830078,130,2.13591812764279,0.062848171131531 +-149.88889,58.180621,13.719616,240970.063115942,916363.791512127,119.093421936035,130,2.07588777411269,-0.155199207258567 +-149.82587,58.1785544,13.719616,244673.614145174,916363.76593071,124.672515869141,130,2.09577072355114,-0.0829786597393438 +-149.76285,58.1764564,13.719616,248377.605857932,916363.767901293,117.263534545898,130,2.06916298050753,-0.179625577079701 +-149.69983,58.1743269,13.719616,252082.045580241,916363.787344952,112.191276550293,31,2.04995908959967,-0.249379590193209 +-149.63683,58.1721661,13.719616,255785.767688706,916363.770616328,111.52710723877,31,2.04738043772871,-0.258745989809078 +-149.57383,58.1699739,13.719616,259489.950284273,916363.782467634,114.05615234375,131,2.05711871667866,-0.223373781081312 +-149.51084,58.1677504,13.719616,263194.013814975,916363.795532942,112.006011962891,131,2.049241334208,-0.251986682643562 +-149.44786,58.1654954,13.719616,266897.966374948,916363.786977605,112.817665100098,131,2.0523771072256,-0.240596660004888 +-149.38489,58.1632091,13.719616,270601.813037679,916363.778571561,112.235176086426,131,2.05012899226774,-0.248762455207745 +-149.32193,58.1608914,13.719616,274305.561149195,916363.758659646,115.433235168457,131,2.06233086750422,-0.204441761586905 +-149.25897,58.1585424,13.719616,278009.801896524,916363.779755808,121.757507324219,131,2.0854957484408,-0.120300302109957 +-149.19602,58.156162,13.719616,281713.957248054,916363.78949137,119.489280700684,131,2.07732894677914,-0.149964456782403 +-149.13308,58.1537503,13.719616,285418.032970867,916363.798548215,114.761642456055,131,2.05979675519349,-0.213646380807161 +-149.07015,58.1513072,13.719616,289122.036444893,916363.795337138,120.486679077148,131,2.08093903427121,-0.136851588589613 +-149.00723,58.1488328,13.719616,292825.973411817,916363.790569811,121.852844238281,131,2.08583567075976,-0.119065607224008 +-148.94432,58.1463271,13.719616,296529.850418628,916363.783830212,126.839027404785,134,2.10325290321981,-0.0558012475560402 +-148.88142,58.14379,13.719616,300233.674870379,916363.763578578,203.672973632812,134,2.30893340415555,0.691289038902325 +-148.81852,58.1412217,13.719616,303938.036994298,916363.797475803,334.416320800781,134,2.52428746452283,1.47351645432476 +-148.75564,58.138622,13.719616,307641.774272465,916363.771900338,596.501281738281,330,2.77561138120211,2.38639665469156 +-136.03522,56.9336264,13.719616,1078073.81730927,916363.782589165,248.88655090332,150,2.39600142924707,1.00754495772327 +-135.97648,56.9247431,13.719616,1081777.76478192,916363.76269129,183.899856567383,150,2.26458139051041,0.530189866018129 +-135.91777,56.9158315,13.719616,1085481.64609369,916363.731201152,167.574905395508,150,2.22420898288468,0.383545758089088 +-135.85908,56.9068916,13.719616,1089186.05134209,916363.850950326,146.781280517578,150,2.16667067215835,0.174550190462142 +-135.80043,56.8979233,13.719616,1092889.81745494,916363.782574247,139.578506469727,150,2.14481854693855,0.0951770344463132 +-135.74181,56.8889267,13.719616,1096593.53151682,916363.699114256,132.154220581055,150,2.12108103765912,0.00895562538373709 +-135.68321,56.8799019,13.719616,1100297.78056862,916363.775840803,147.149291992188,150,2.16775817683573,0.1785003178551 +-135.62464,56.8708488,13.719616,1104001.9869151,916363.836308566,43.6209373474121,50,1.63969499366897,-1.73957588764487 +-135.56611,56.8617674,10.65848577,1107705.56983503,916363.712593675,36.2136192321777,50,1.55887193089314,-2.03314832084556 +-135.09887,56.7881023,3.559598128,1137337.95252698,916363.819213025,44.517635345459,50,1.64853208774504,-1.70747703960282 +-154.12285,58.214186,12.77811582,-7198.4332492485,912659.771187231,25.5927410125732,20,1.40811680182646,-2.58073397941352 +-154.05963,58.2142316,13.719616,-3494.03500022909,912659.776778274,257.890319824219,121,2.41143504075823,1.06360423992311 +-153.99642,58.2142456,13.719616,209.770953335441,912659.778034871,261.787780761719,121,2.41794937150578,1.08726614857331 +-153.93321,58.214228,13.719616,3913.57729003689,912659.773865951,221.457122802734,121,2.34528965321042,0.823345312576207 +-153.86999,58.2141789,13.719616,7617.97666659315,912659.776600719,206.402069091797,232,2.31471404659202,0.712285982191213 +-153.80678,58.2140982,13.719616,11321.8039050137,912659.773354918,196.754470825195,132,2.29392460955792,0.636772812987255 +-153.74357,58.213986,13.719616,15025.6516406586,912659.775932455,190.967193603516,132,2.2809587658828,0.589677167938997 +-153.68036,58.2138422,13.719616,18729.5266214266,912659.773217981,187.696716308594,132,2.2734566748508,0.562427432000774 +-153.61714,58.2136669,13.719616,22434.0214612052,912659.779836418,184.96028137207,132,2.26707847741433,0.539259998392754 +-153.55393,58.21346,13.719616,26137.9710241374,912659.778506654,183.495620727539,132,2.26362570392021,0.526718539542417 +-153.49072,58.2132215,13.719616,29841.9679882028,912659.772155442,182.973007202148,132,2.26238702586261,0.522219307283303 +-153.42751,58.2129516,13.719616,33546.018886164,912659.78325089,188.720886230469,132,2.27581996732274,0.571011584809711 +-153.36431,58.21265,13.719616,37249.5447478469,912659.772804592,208.012100219727,132,2.318088598933,0.724543319486756 +-153.3011,58.2123169,13.719616,40953.723999654,912659.773977195,199.960784912109,132,2.30094483283315,0.66227226769409 +-153.23789,58.2119523,13.56175832,44657.9773819213,912659.781888557,63.5510330200195,35,1.80312261439039,-1.14596012229766 +-153.11149,58.2111283,10.1929931,52065.5618507674,912659.769496528,74.2024383544922,35,1.87041817679522,-0.901523431577474 +-153.04828,58.210669,12.35529093,55770.0781295394,912659.775353398,103.394821166992,35,2.01449878638922,-0.378181532831796 +-152.29004,58.2026975,8.727242565,100217.661724094,912659.774492485,29.754695892334,30,1.47355551591971,-2.34304189175829 +-152.22687,58.2018282,9.468056226,103921.669954022,912659.76919404,17.8729267120361,30,1.25219567454333,-3.14708401802638 +-152.03738,58.1990314,7.801971823,115033.677042802,912659.777670189,12.9726867675781,30,1.11302993194316,-3.65257371700776 +-151.97422,58.198036,13.09537601,118737.891679278,912659.77570081,50.715389251709,30,1.70513976313941,-1.50186180513129 +-151.91107,58.1970092,11.44072956,122441.734742913,912659.774956117,45.5877723693848,30,1.65884837107188,-1.67000535399933 +-151.78478,58.194861,11.57711981,129849.506135391,912659.767004517,27.4056377410889,30,1.43783991274696,-2.47277115672979 +-151.72163,58.1937396,13.719616,133554.033793437,912659.779894661,43.9527282714844,30,1.64298583814644,-1.72762260120218 +-151.6585,58.1925868,13.719616,137257.63059489,912659.772197069,66.5047988891602,30,1.82285298448936,-1.0742937864899 +-151.59536,58.1914024,13.719616,140962.061849271,912659.782501014,67.2313919067383,30,1.82757210264485,-1.05715260237873 +-151.53224,58.1901866,13.719616,144665.57557535,912659.770068288,120.95369720459,130,2.08261914802664,-0.130748935877702 +-151.46911,58.1889392,13.719616,148369.937122972,912659.776868309,154.941329956055,130,2.19016727946146,0.259896574786441 +-151.40599,58.1876604,13.719616,152073.980418646,912659.781745892,163.923828125,130,2.21464208762197,0.34879606383118 +-151.34288,58.1863501,13.719616,155777.712548354,912659.772518017,160.128402709961,130,2.2044683715581,0.311842223219528 +-151.27977,58.1850083,13.719616,159481.726134226,912659.772197276,141.727828979492,130,2.15145513454938,0.119283014919536 +-151.21666,58.183635,13.719616,163186.027844809,912659.781471201,132.734512329102,130,2.12298385854894,0.0158672139747236 +-151.15356,58.1822303,13.719616,166890.03791631,912659.787076137,151.415725708008,130,2.18017098238695,0.223587170584581 +-151.09047,58.1807941,13.719616,170593.763472331,912659.776894958,144.645263671875,130,2.16030421748731,0.151425409929853 +-151.02738,58.1793264,13.719616,174297.797130056,912659.77623541,110.784843444824,31,2.04448034831182,-0.269279942339129 +-150.9643,58.1778273,13.719616,178001.559090053,912659.770207261,146.816040039062,130,2.16677350598814,0.174923712283644 +-150.90122,58.1762967,13.719616,181705.642456206,912659.774103645,140.345031738281,130,2.14719704307064,0.103816411288433 +-150.83814,58.1747346,13.719616,185410.053889314,912659.788708249,107.715919494629,130,2.03227989306354,-0.313595478157535 +-150.77508,58.1731411,13.719616,189113.627601685,912659.769027893,110.379707336426,130,2.04288923823129,-0.275059308299649 +-150.71202,58.1715161,13.719616,192817.542677218,912659.759439183,117.780258178711,130,2.07107250197437,-0.172689650080458 +-150.64896,58.1698597,13.719616,196521.805208934,912659.77193232,117.443939208984,130,2.0698306095682,-0.177200557771049 +-150.58591,58.1681719,13.719616,200225.835867742,912659.777203869,110.543022155762,130,2.04353133366379,-0.272727034416546 +-150.52287,58.1664526,13.719616,203929.641860151,912659.763285181,116.881568908691,130,2.06774603252766,-0.184772336579793 +-150.45983,58.1647019,13.719616,207633.815195292,912659.771804371,119.704315185547,130,2.07810980644227,-0.147128151606364 +-150.3968,58.1629198,13.719616,211337.776539501,912659.771832567,125.339492797852,130,2.09808793293983,-0.0745618938422192 +-150.33378,58.1611063,13.719616,215041.532509924,912659.762606282,133.478500366211,130,2.12541131870243,0.0246844421182897 +-150.27076,58.1592613,13.719616,218745.676301538,912659.765160975,150.769973754883,130,2.17831485923283,0.216845201498534 +-150.20775,58.157385,13.719616,222449.627332331,912659.769252961,160.040374755859,130,2.20422955966654,0.310974790265675 +-150.14474,58.1554772,13.719616,226153.979431626,912659.785910549,172.583221435547,130,2.2369985712624,0.430001193588929 +-150.08175,58.153538,13.719616,229857.566678148,912659.7580393,182.636978149414,130,2.26158871284983,0.519319606559676 +-150.01876,58.1515675,13.719616,233561.566916117,912659.764772629,186.772888183594,130,2.27131383459853,0.55464402457704 +-149.95577,58.1495655,13.719616,237265.988080799,912659.784809805,186.948318481445,230,2.27172156321843,0.556125011301874 +-149.8928,58.1475322,13.719616,240969.663523415,912659.768906816,196.769180297852,130,2.29395707643909,0.636890741966636 +-149.82983,58.1454675,13.719616,244673.772421631,912659.777285966,196.690032958984,130,2.29378235310395,0.6362560969424 +-149.76687,58.1433714,13.719616,248377.735424751,912659.773599624,179.679077148438,130,2.25449750833874,0.49356232774411 +-149.70392,58.1412439,13.719616,252081.559132616,912659.757242825,171.29133605957,130,2.23373539684363,0.418148412697269 +-149.64097,58.1390851,13.719616,255785.835362758,912659.777290316,167.993408203125,131,2.2252922410284,0.387480460859752 +-149.57803,58.1368949,13.719616,259489.985470512,912659.784618841,165.068069458008,131,2.21766307205542,0.359769141568275 +-149.5151,58.1346734,13.719616,263194.015296058,912659.789817723,149.114456176758,131,2.17351974897585,0.199427992384446 +-149.45218,58.1324205,13.719616,266897.932164345,912659.781196673,139.300674438477,131,2.14395321911025,0.0920339167847749 +-149.38927,58.1301363,13.719616,270601.741890489,912659.769375023,134.303451538086,131,2.1280871739843,0.0344039122671853 +-149.32636,58.1278208,13.719616,274306.036983336,912659.795144418,131.672653198242,131,2.11949558666775,0.00319681485030372 +-149.26347,58.1254739,13.719616,278009.652888708,912659.764813165,129.560409545898,131,2.11247231216341,-0.0223137227915586 +-149.20058,58.1230957,13.719616,281713.767288685,912659.772211718,120.213088989258,131,2.07995175690407,-0.140437661784085 +-149.1377,58.1206862,13.719616,285417.800781157,912659.775570244,109.788681030273,131,2.0405575676233,-0.283528601472924 +-149.07483,58.1182454,13.719616,289121.759914274,912659.774438793,104.668327331543,131,2.01981528391283,-0.358870496346572 +-149.01197,58.1157733,13.719616,292825.651234044,912659.768383066,105.793792724609,134,2.02446018693798,-0.341998882771898 +-148.94911,58.1132699,13.719616,296530.067236683,912659.801635048,114.909660339355,134,2.06035654092255,-0.211613079260435 +-148.88627,58.1107352,13.719616,300233.842559059,912659.78504806,141.760635375977,134,2.15155565106994,0.119648119612479 +-148.82344,58.1081692,13.719616,303937.569692961,912659.762327608,189.236709594727,134,2.27700538802757,0.575317371162399 +-148.76061,58.1055719,13.719616,307641.841127925,912659.779425688,691.790649414062,330,2.83997468757814,2.62018255456594 +-136.0515,56.9016418,13.719616,1078073.74798295,912659.762270956,428.640228271484,351,2.63209292754684,1.86509666677061 +-135.99281,56.8927661,13.719616,1081777.57144775,912659.714133246,193.832305908203,150,2.28742616233493,0.613168597831852 +-135.93414,56.8838621,13.719616,1085481.91085581,912659.814279504,192.792861938477,150,2.28509095032346,0.604686441270311 +-135.87551,56.8749297,13.719616,1089185.60201275,912659.724441011,172.572875976562,150,2.23697253680561,0.429906629010913 +-135.8169,56.865969,13.719616,1092889.81853103,912659.781652363,149.346282958984,150,2.1741944180316,0.201878582964666 +-135.75832,56.8569801,13.719616,1096593.97612225,912659.832041889,136.844543457031,150,2.13622748502165,0.0639718454309356 +-135.69978,56.8479628,13.719616,1100297.49956299,912659.687291164,132.756774902344,150,2.12305669342677,0.0161317710401325 +-135.64126,56.8389174,13.719616,1104001.55632842,912659.709271339,120.313629150391,150,2.08031482708663,-0.139118887250482 +-135.58277,56.8298437,13.70233598,1107705.57119278,912659.71024303,44.2714347839355,50,1.64612359716856,-1.71622536482825 +-135.52431,56.8207418,12.99433266,1111409.54575876,912659.699809418,53.1141319274902,50,1.72521008796607,-1.42896065671983 +-135.46587,56.8116118,11.30033092,1115114.06753786,912659.855482541,44.3166389465332,50,1.64656681529607,-1.7146154700821 +-135.05769,56.7469141,4.529094808,1141041.53339628,912659.705300914,83.6869430541992,50,1.92265770408821,-0.711774557803771 +-154.24903,58.1808491,6.112373385,-14605.930032773,908955.773372352,26.8089141845703,20,1.42827922453122,-2.50749830522146 +-154.18588,58.1809577,10.9944438,-10902.0786043856,908955.779278122,17.3279438018799,20,1.23874703077634,-3.19593333081318 +-154.12273,58.1810347,13.70611359,-7198.24691868597,908955.776577514,83.6593704223633,20,1.92251459197875,-0.712294381833603 +-154.05958,58.1810802,13.719616,-3494.42824299055,908955.776403774,280.285888671875,121,2.44760123323582,1.19497017386078 +-153.99642,58.1810942,13.719616,209.970623668863,908955.77876515,239.419891357422,232,2.37916022939494,0.946372912903342 +-153.93327,58.1810766,13.719616,3913.78336314621,908955.77297618,210.085174560547,232,2.32239540588657,0.740186871627213 +-153.87012,58.1810276,13.719616,7617.6031646035,908955.780865397,202.288513183594,232,2.30597122235253,0.680529549102907 +-153.80696,58.180947,13.719616,11322.0232620764,908955.781817116,196.158447265625,132,2.29260701510056,0.631986933839206 +-153.74381,58.1808348,13.719616,15025.877357982,908955.773020896,195.296356201172,132,2.29069414038726,0.625038826891696 +-153.68066,58.1806912,13.719616,18729.7585775558,908955.778026889,191.873428344727,132,2.28301483548441,0.597145399592726 +-153.61751,58.180516,13.719616,22433.6737082004,908955.774563319,190.887359619141,132,2.28077717077496,0.589017562674885 +-153.55436,58.1803093,13.719616,26137.6293972526,908955.773892817,190.171371459961,132,2.27914513850692,0.583089555648981 +-153.49121,58.1800711,13.719616,29841.6323349731,908955.776121422,192.140563964844,132,2.2836190610948,0.599340119472818 +-153.42806,58.1798013,13.719616,33545.6893076441,908955.770198891,200.207962036133,132,2.30148134486957,0.664221032546146 +-153.36491,58.1795001,13.719616,37249.8068232788,908955.778608544,214.708465576172,132,2.3318491682394,0.774525634865127 +-153.30176,58.1791673,13.719616,40953.9917745192,908955.77916018,126.872344970703,132,2.10336696696852,-0.0553869354636894 +-153.23862,58.178803,11.54950952,44657.6642443094,908955.77647245,47.5,35,1.67669360962487,-1.60518635403669 +-152.92291,58.1765087,5.749508225,63177.9581785651,908955.781682873,17.5360240936279,35,1.24393113350378,-3.17710319001688 +-152.29166,58.1695568,12.32471549,100217.975986747,908955.78487186,49.1683197021484,30,1.69168536679018,-1.55073201293876 +-152.22855,58.1686883,13.47573065,103921.983561271,908955.779405596,127.259925842285,30,2.10469166582543,-0.0505752511086787 +-152.16545,58.1677884,9.264482878,107625.592034848,908955.773298464,16.0616989135742,30,1.20579148052968,-3.31563729575957 +-152.03924,58.165894,12.13926923,115033.985627913,908955.778940521,37.9946136474609,30,1.57972203269598,-1.9574147998861 +-151.97615,58.1648996,13.719616,118737.610764018,908955.768185577,66.4581680297852,30,1.82254836544824,-1.07540024979416 +-151.91305,58.1638737,13.719616,122442.03681888,908955.779974063,54.8008346557617,30,1.73878717314917,-1.37964480804889 +-151.84997,58.1628164,11.15492997,126145.5105763,908955.770687503,22.1893901824951,30,1.3461453669451,-2.80583191931118 +-151.78688,58.1617275,13.719616,129849.798954221,908955.773844391,39.9594764709473,30,1.60161978968237,-1.87787589626941 +-151.7238,58.1606072,13.719616,133553.734872403,908955.773788634,64.9604721069336,30,1.81264917252455,-1.11135694400399 +-151.66072,58.1594554,13.719616,137257.911875543,908955.778921872,69.147102355957,30,1.83977398549832,-1.01283188109081 +-151.59765,58.1582722,13.719616,140961.749721348,908955.779773637,112.938194274902,130,2.05284083968991,-0.238912251332112 +-151.53458,58.1570574,13.719616,144665.842388321,908955.774728963,143.407577514648,130,2.15657209962923,0.137869292616786 +-151.47152,58.1558112,13.719616,148369.609217374,908955.764398927,156.396636962891,130,2.19422741007829,0.274644128063433 +-151.40846,58.1545336,13.719616,152073.643355486,908955.770645968,157.398727416992,130,2.19700121672691,0.284719385534446 +-151.3454,58.1532245,13.719616,155777.95188486,908955.782959162,138.943511962891,130,2.1428382719878,0.0879841105984314 +-151.28235,58.1518839,13.719616,159481.954961747,908955.777994228,146.455078125,130,2.16570443483244,0.171040540702838 +-151.21931,58.1505119,13.719616,163185.658783653,908955.765926827,144.072952270508,130,2.15858245560763,0.14517147934306 +-151.15627,58.1491085,13.719616,166889.656492866,908955.77091433,137.173599243164,130,2.13727053406534,0.067760497273465 +-151.09323,58.1476736,13.719616,170593.955209178,908955.782511592,128.055847167969,130,2.10739941361122,-0.0407399382825333 +-151.0302,58.1462073,13.719616,174297.97458445,908955.786368775,105.004783630371,31,2.02120908437424,-0.353807815240474 +-150.96718,58.1447095,13.719616,178001.721757089,908955.770400442,136.959838867188,130,2.13659323638731,0.065300358786839 +-150.90416,58.1431803,13.719616,181705.789375386,908955.772220633,155.760955810547,130,2.19245860352207,0.26821931778359 +-150.84115,58.1416197,13.719616,185409.597554895,908955.764691388,143.975158691406,130,2.15828756588758,0.144100355709935 +-150.77814,58.1400277,13.719616,189113.739430038,908955.775412214,130.054153442383,130,2.11412422649194,-0.016313498447075 +-150.71514,58.1384042,13.719616,192817.635665977,908955.765002749,135.815734863281,130,2.1329500878269,0.0520674033572929 +-150.65214,58.1367494,13.719616,196521.87830008,908955.78452796,130.708984375,130,2.1163054401466,-0.00839070787296095 +-150.58915,58.1350631,13.719616,200225.888557586,908955.782365591,155.794235229492,130,2.19255138366812,0.268556321756138 +-150.52617,58.1333454,13.719616,203929.672504591,908955.76886136,166.936050415039,130,2.2225501341967,0.377520346171798 +-150.46319,58.1315963,13.719616,207633.823268191,908955.774483075,155.272094726562,130,2.19109341197313,0.263260552413356 +-150.40022,58.1298159,13.719616,211337.760348389,908955.779455971,169.933959960938,130,2.23028017786754,0.405598071158425 +-150.33725,58.128004,13.719616,215042.078069173,908955.793082507,188.373458862305,130,2.27501971224858,0.568104829964825 +-150.2743,58.1261607,13.719616,218745.609427828,908955.761566599,225.490798950195,130,2.35312882538611,0.851819423440842 +-150.21135,58.1242861,13.719616,222449.533418192,908955.760647353,239.702743530273,130,2.37967300480228,0.948235459543464 +-150.1484,58.1223801,13.719616,226153.857265098,908955.780124709,247.290451049805,230,2.39320734670321,0.997396052413423 +-150.08546,58.1204427,13.719616,229858.001065696,908955.786358542,267.644592285156,230,2.42755847295972,1.12216914776464 +-150.02253,58.118474,13.719616,233561.970756821,908955.789814909,268.246490478516,230,2.42853404871521,1.12571271736563 +-149.95961,58.1164739,13.719616,237265.773589884,908955.778669885,255.666366577148,230,2.40767359947457,1.04994161155861 +-149.89669,58.1144424,13.719616,240970.002677059,908955.788553534,254.585159301758,230,2.40583308344486,1.04325633200314 +-149.83378,58.1123796,13.719616,244674.077408064,908955.794808238,266.299713134766,230,2.42537069860546,1.11422252685701 +-149.77088,58.1102854,13.719616,248378.005060626,908955.785659374,254.379348754883,130,2.4054818511358,1.04198055600496 +-149.70799,58.1081599,13.719616,252081.791509794,908955.77164866,232.971878051758,230,2.36730350066534,0.903305889910114 +-149.6451,58.1060031,13.719616,255786.029828721,908955.790698106,236.071197509766,230,2.37304300306507,0.924153400843003 +-149.58223,58.1038149,13.719616,259489.554300949,908955.754609049,221.805847167969,230,2.3459729906829,0.825827389320188 +-149.51936,58.1015955,13.719616,263193.543031203,908955.76270385,198.813171386719,230,2.29844515305467,0.653192717259017 +-149.45649,58.0993447,13.719616,266898.004072576,908955.793815111,186.837387084961,230,2.27146378506341,0.555188687465619 +-149.39364,58.0970626,13.719616,270601.770217464,908955.778739765,153.488708496094,131,2.18607643181183,0.245037448478815 +-149.33079,58.0947491,13.719616,274306.02182422,908955.786753541,144.367111206055,131,2.15946826630438,0.148388996629212 +-149.26796,58.0924044,13.719616,278009.59086471,908955.75759604,140.152557373047,131,2.14660102676894,0.101651509960673 +-149.20513,58.0900284,13.719616,281713.657682649,908955.762804453,113.946197509766,131,2.05669983694877,-0.224895271820433 +-149.14231,58.0876211,13.719616,285417.642315006,908955.760606449,108.798500061035,131,2.03662290804869,-0.297820408111577 +-149.0795,58.0851826,13.719616,289121.550479765,908955.761690888,107.278511047363,131,2.03051273717388,-0.320014292745276 +-149.01669,58.0827127,13.719616,292825.976873335,908955.787430288,104.241912841797,134,2.01804237209262,-0.365310218116961 +-148.9539,58.0802116,13.719616,296529.75335162,908955.772057163,106.380432128906,134,2.02686175013965,-0.33327571974905 +-148.89111,58.0776792,13.719616,300234.06030033,908955.79276806,131.419967651367,134,2.11866135595422,0.000166650785614793 +-148.82834,58.0751156,13.719616,303937.730366355,908955.770451808,189.37663269043,231,2.27732639008605,0.576483342261916 +-148.76557,58.0725207,13.719616,307641.943952008,908955.784568672,687.325866699219,330,2.83716268837778,2.60996857084573 +-136.06775,56.8696539,12.98049635,1078073.75235018,908955.759129648,683.9443359375,450,2.83502075730651,2.60218846582691 +-136.0091,56.8607858,13.719616,1081778.03350906,908955.846170876,259.782836914062,250,2.4146104551291,1.07513825127158 +-135.95049,56.8518893,13.719616,1085481.65729768,908955.741389771,199.589004516602,150,2.30013661205506,0.6593365791389 +-135.8919,56.8429645,13.719616,1089185.79846167,908955.78069208,193.861557006836,150,2.28749169646877,0.61340663651125 +-135.83334,56.8340114,13.719616,1092889.87518718,908955.800006598,176.806304931641,150,2.24749774794061,0.46813720004759 +-135.77481,56.82503,13.719616,1096593.89216461,908955.798162689,155.123458862305,150,2.19067747985137,0.261749768228286 +-135.71631,56.8160205,13.719616,1100297.84801165,908955.795475766,139.843109130859,150,2.14564107106382,0.0981646768410565 +-135.65784,56.8069827,13.719616,1104001.75343608,908955.769305937,132.427490234375,150,2.12197814838037,0.012214187584199 +-135.5994,56.7979167,13.719616,1107705.61005839,908955.729243176,117.402770996094,150,2.06967834745768,-0.177753617216363 +-135.54098,56.7888225,13.719616,1111410.00902733,908955.841498622,108.072853088379,150,2.0337166168531,-0.308376887272052 +-135.4826,56.7797001,13.47360929,1115113.78195538,908955.770790925,48.7834205627441,50,1.68827224861082,-1.56312943236713 +-135.42425,56.7705496,13.20907802,1118817.51689899,908955.69351621,65.7952728271484,50,1.81819469211194,-1.0912140340137 +-135.36592,56.761371,11.87391574,1122521.80496103,908955.777577735,25.9984741210938,50,1.41494785950023,-2.55592162816444 +-135.30762,56.7521643,10.40917441,1126226.06421821,908955.853950651,22.7926540374756,50,1.3577948985336,-2.7635174954744 +-154.43807,58.1471828,6.380746199,-25718.0547470148,905251.779399143,23.6737117767334,20,1.37426635584943,-2.70368846108132 +-154.18571,58.1478055,13.40703695,-10902.4656636107,905251.771702505,113.371696472168,20,2.05450464538404,-0.232868834153591 +-154.12261,58.1478825,13.719616,-7198.0472143522,905251.775506898,270.582763671875,20,2.43230012825344,1.13939219319461 +-154.05952,58.147928,13.719616,-3494.22883627478,905251.780223109,266.302764892578,121,2.42537567553153,1.11424060447304 +-153.99643,58.1479419,13.719616,209.583226489913,905251.773013653,218.638107299805,232,2.33972585911267,0.803136024348233 +-153.93333,58.1479244,13.719616,3913.98273865265,905251.776805775,205.942306518555,232,2.31374557245681,0.70876820770207 +-153.87024,58.1478754,13.719616,7617.80224191614,905251.779815012,199.165618896484,232,2.29921437017078,0.655986733381149 +-153.80715,58.1477948,13.719616,11321.6355239897,905251.770925556,196.035232543945,232,2.29233413219484,0.630995745237103 +-153.74405,58.1476828,13.719616,15026.0762858082,905251.774786255,196.354049682617,132,2.29303986275784,0.63355916007747 +-153.68096,58.1475393,13.719616,18729.9571007375,905251.776314594,196.02587890625,132,2.29231340974561,0.630920475386742 +-153.61787,58.1473643,13.719616,22433.8717237873,905251.777288948,197.022430419922,132,2.29451567211623,0.638919720905065 +-153.55478,58.1471578,13.719616,26137.8268419597,905251.777798971,199.013671875,132,2.29888291267058,0.654782785133029 +-153.49169,58.1469198,13.719616,29841.8291420799,905251.777950482,205.843948364258,132,2.31353810363546,0.708014621725442 +-153.4286,58.1466503,13.719616,33545.8853107835,905251.777865428,217.109939575195,132,2.33667970647536,0.792071528511016 +-153.36551,58.1463493,13.719616,37250.0020344656,905251.777681879,172.301940917969,132,2.23629016964313,0.427428076709796 +-153.30243,58.1460168,9.00606653,40953.5989314145,905251.771387354,22.205135345459,35,1.34645342464353,-2.80471296582205 +-153.23934,58.1456529,11.08300984,44657.856695242,905251.782099672,114.885971069336,35,2.06026699945283,-0.211938319436153 +-152.23024,58.1355475,13.719616,103921.522930774,905251.765339404,63.6886100769043,30,1.80406177106312,-1.14254883720028 +-152.16719,58.1346484,13.719616,107625.71031266,905251.77128783,108.484901428223,30,2.03536929871272,-0.302373875035525 +-152.10415,58.1337179,13.62374477,111329.504414279,905251.773224478,34.0674705505371,30,1.53233988916738,-2.12952026939215 +-152.04111,58.1327558,13.719616,115033.499605745,905251.764937817,55.1614685058594,30,1.74163581942372,-1.36929771169514 +-151.97807,58.1317623,13.719616,118737.701912865,905251.769255637,56.5060577392578,30,1.75209500891161,-1.33130695012523 +-151.91504,58.1307374,13.719616,122441.530909311,905251.768248441,53.7968330383301,30,1.73075670997009,-1.4088137424377 +-151.85201,58.129681,13.719616,126145.58066486,905251.768594583,61.1301498413086,30,1.78625546032722,-1.20722644022016 +-151.78898,58.1285932,13.719616,129849.857479107,905251.782000764,68.6020050048828,30,1.83633680885299,-1.02531668773454 +-151.72596,58.1274739,13.719616,133553.781305415,905251.777746461,91.6083450317383,30,1.96193503738136,-0.569108072415985 +-151.66294,58.1263232,13.719616,137257.945488085,905251.786564406,118.736335754395,130,2.07458364231447,-0.159936186185985 +-151.59993,58.125141,13.719616,140961.769999666,905251.776651357,123.422554016113,130,2.0913945291439,-0.098874246916667 +-151.53692,58.1239274,13.719616,144665.848161211,905251.77988678,153.351135253906,130,2.18568699539957,0.243622904273294 +-151.47392,58.1226823,13.719616,148369.599964331,905251.763384779,143.162048339844,130,2.15582790357887,0.135166160147197 +-151.41092,58.1214059,13.719616,152073.618271266,905251.771335325,128.893753051758,130,2.11023186940233,-0.0304516503858549 +-151.34792,58.120098,13.719616,155777.910574709,905251.782061737,134.631988525391,130,2.12914826040438,0.0382580810091375 +-151.28493,58.1187587,13.719616,159481.896013164,905251.783381314,149.522705078125,130,2.17470714544592,0.203740955280439 +-151.22195,58.1173879,13.719616,163185.581683891,905251.763141651,152.962615966797,130,2.18458530230016,0.239621240481702 +-151.15897,58.1159858,13.719616,166889.560359735,905251.767824105,119.111434936523,130,2.07595345662506,-0.154960629625971 +-151.09599,58.1145522,13.719616,170593.839613303,905251.775819322,128.159805297852,130,2.10775183895448,-0.0394598288435985 +-151.03302,58.1130872,13.719616,174297.838535842,905251.7727757,106.608734130859,31,2.02779278658033,-0.329893929652243 +-150.97006,58.1115909,13.719616,178001.563242833,905251.768927741,135.094833374023,130,2.13063873999125,0.0436719282938772 +-150.9071,58.1100631,13.719616,181705.608434351,905251.76840428,157.320709228516,130,2.19678589561552,0.283937277799108 +-150.84414,58.1085039,13.719616,185409.980233789,905251.783145356,151.241851806641,130,2.17967198622873,0.221774674110239 +-150.7812,58.1069133,13.719616,189113.511126399,905251.756993306,155.480163574219,130,2.19167498886265,0.265373005674662 +-150.71825,58.1052914,13.719616,192817.96838348,905251.785672899,154.04573059082,130,2.18764966625866,0.250751885035525 +-150.65532,58.103638,13.719616,196521.59851272,905251.760591213,132.518524169922,130,2.12227659059335,0.0132982148856368 +-150.59239,58.1019533,13.719616,200225.581152228,905251.761859743,149.399368286133,130,2.17434876113114,0.202439201156093 +-150.52946,58.1002372,13.719616,203929.923469052,905251.77917831,180.352478027344,130,2.25612211386374,0.499463358719496 +-150.46654,58.0984898,13.719616,207634.044414856,905251.793312507,184.622894287109,130,2.26628555501084,0.53637987790069 +-150.40363,58.0967109,13.719616,211337.951779486,905251.781165958,202.14860534668,130,2.30567074941775,0.679438145640251 +-150.34073,58.0949007,13.719616,215041.650974639,905251.764283436,218.944412231445,230,2.34033386586513,0.805344478415602 +-150.27783,58.0930592,13.719616,218745.735645439,905251.774849817,238.631484985352,230,2.37772774383267,0.941169716469072 +-150.21494,58.0911863,13.719616,222449.625936061,905251.769151051,280.313781738281,230,2.44764445054569,1.19512715146567 +-150.15205,58.089282,13.719616,226153.915520044,905251.780520914,303.585266113281,230,2.48228069014514,1.32093585985789 +-150.08917,58.0873464,13.719616,229858.023275998,905251.786469914,314.704345703125,230,2.49790274005925,1.37767960412293 +-150.0263,58.0853795,13.719616,233561.955774529,905251.786307876,300.850616455078,230,2.47835090571554,1.30666176113745 +-149.96344,58.0833812,13.719616,237265.72026315,905251.768209051,298.842407226562,230,2.47544222606732,1.29609660643529 +-149.90058,58.0813516,13.719616,240969.909719318,905251.778952068,281.648864746094,230,2.44970800504589,1.2026225704075 +-149.83773,58.0792907,13.719616,244673.943640504,905251.782724884,272.194396972656,230,2.4348791811579,1.1487600494786 +-149.77489,58.0771985,13.719616,248377.828590234,905251.778900285,253.480514526367,230,2.40394458000494,1.03639674847681 +-149.71206,58.075075,13.719616,252081.571130189,905251.766866796,226.008804321289,134,2.35412535770349,0.855439113256174 +-149.64923,58.0729201,13.719616,255785.765619427,905251.773396205,219.392837524414,230,2.34122244514207,0.808572051975206 +-149.58641,58.070734,13.719616,259489.830095796,905251.782804913,227.688491821289,230,2.35734108039637,0.867119535935354 +-149.5236,58.0685165,13.719616,263193.7725886,905251.772233351,204.778442382812,230,2.31128423527757,0.69982792853149 +-149.4608,58.0662678,13.719616,266897.598157503,905251.763426471,204.220230102539,230,2.31009876119224,0.695521948285603 +-149.398,58.0639878,13.719616,270601.901164368,905251.785450417,202.87255859375,230,2.30722330648485,0.685077476051868 +-149.33522,58.0616765,13.719616,274305.514023551,905251.756852463,170.195922851562,131,2.23094915208067,0.408027976444742 +-149.27244,58.0593339,13.719616,278009.617418821,905251.759181497,160.368103027344,131,2.2051179920232,0.314201830168905 +-149.20967,58.0569601,13.719616,281713.630023163,905251.762347525,125.78581237793,131,2.09963165896733,-0.0689546402870351 +-149.14691,58.054555,13.719616,285417.559164566,905251.754735659,109.664703369141,131,2.04006686824325,-0.285310961680813 +-149.08415,58.0521187,13.719616,289121.997626498,905251.790567178,115.627212524414,134,2.06306005604288,-0.201793140683376 +-149.02141,58.0496511,13.719616,292825.778618037,905251.771747266,115.043266296387,134,2.06086120365737,-0.209780000162504 +-148.95867,58.0471523,13.719616,296530.081965166,905251.796619683,129.707748413086,134,2.11296592051379,-0.0205207963731368 +-148.89595,58.0446223,13.719616,300233.740035916,905251.776029996,227.338775634766,231,2.35667351671038,0.864694754086202 +-148.83323,58.042061,13.719616,303937.934335816,905251.788304198,415.228179931641,231,2.61828681972845,1.81494894251871 +-148.77052,58.0394685,13.719616,307642.083449069,905251.799551317,680.839599609375,330,2.83304480764011,2.59501125264637 +-148.70783,58.0368448,13.719616,311345.606804857,905251.762525426,652.720642089844,430,2.81472734734277,2.5284770085227 +-136.02537,56.8288021,13.719616,1081777.98598312,905251.823702723,252.568954467773,351,2.40237996644119,1.03071362542811 +-135.9668,56.8199132,13.719616,1085482.05937514,905251.8516141,224.523361206055,250,2.35126153516137,0.845036892366872 +-135.90826,56.8109959,13.719616,1089186.06278925,905251.846387364,204.905426025391,150,2.31155345894626,0.700805825740289 +-135.84975,56.8020504,13.719616,1092889.99492608,905251.828332244,188.955291748047,150,2.27635905896696,0.57296971953357 +-135.79127,56.7930767,13.719616,1096593.86044736,905251.796262722,170.440505981445,150,2.23157281480689,0.410293297477456 +-135.73282,56.7840747,13.719616,1100297.66703964,905251.738263304,159.41032409668,150,2.20251644474531,0.304752267900093 +-135.67439,56.7750445,13.719616,1104002.00340902,905251.830148421,147.217102050781,150,2.16795826445022,0.179227093181634 +-135.616,56.7659862,13.719616,1107705.69701449,905251.749575373,132.226898193359,150,2.12131981028345,0.00982291570780638 +-135.55763,56.7568997,13.719616,1111409.92966073,905251.817689344,117.207275390625,150,2.06895457041872,-0.180382582008407 +-135.4993,56.747785,13.719616,1115113.53184446,905251.699201835,107.54712677002,50,2.03159881226329,-0.316069358023863 +-135.44099,56.7386422,13.719616,1118817.6792503,905251.738970753,86.0473937988281,50,1.93473772096308,-0.667896488534163 +-135.38271,56.7294714,13.719616,1122521.78631581,905251.779234757,42.4112930297852,50,1.62748151337318,-1.78393873415354 +-135.32446,56.7202724,12.81321227,1126225.86379231,905251.797425883,36.8652038574219,50,1.56661663980995,-2.0050173274997 +-135.20805,56.7017903,6.089454907,1133633.93283187,905251.816751107,96.0911026000977,50,1.9826831767365,-0.493744908169568 +-134.91755,56.6550951,5.250031846,1152153.79644739,905251.782200507,205.6005859375,50,2.31302434801322,0.706148514665009 +-154.43766,58.1140304,9.750067415,-25718.394239434,901547.78156342,107.284149169922,20,2.0305355613271,-0.31993138890612 +-154.31159,58.1144044,9.448567102,-18309.9603914202,901547.775014669,17.0068168640137,20,1.23062303508474,-3.22544200198429 +-154.24856,58.1145442,13.4359089,-14606.0900937457,901547.773567988,32.8427391052246,20,1.51643937039251,-2.1872754920424 +-154.18553,58.1146526,13.719616,-10902.2460868379,901547.77939637,199.76025390625,20,2.30050908135577,0.660689493952409 +-154.1225,58.1147295,13.719616,-7198.42173927783,901547.781272205,282.009307861328,121,2.45026344266724,1.20464007838592 +-154.05946,58.1147749,13.719616,-3494.02274155204,901547.778629978,234.637435913086,232,2.37039730408568,0.9145434669922 +-153.99643,58.1147888,13.719616,209.782339121929,901547.773056473,210.291381835938,232,2.32282147478908,0.741734475493318 +-153.9334,58.1147713,13.719616,3913.58780113502,901547.774632965,201.272766113281,232,2.30378501519234,0.67258862069143 +-153.87036,58.1147223,13.719616,7617.9879440834,901547.773343206,196.743225097656,232,2.29389978624908,0.636682647644277 +-153.80733,58.1146419,13.719616,11321.8141683287,901547.778648091,194.792572021484,232,2.28957239201084,0.620964316609675 +-153.7443,58.11453,13.719616,15025.660794583,901547.780005854,196.056228637695,232,2.29238064423893,0.631164690257115 +-153.68127,58.1143866,13.719616,18729.5345066721,901547.777473769,197.417633056641,232,2.29538594061928,0.642080784507524 +-153.61823,58.1142117,13.719616,22434.0296139057,901547.774503237,201.07275390625,232,2.30335322609237,0.671020239435472 +-153.5552,58.1140054,13.719616,26137.9774738239,901547.776157475,232.360122680664,232,2.36616159710149,0.899158170234499 +-153.49217,58.1137676,13.719616,29841.9724490437,901547.774190217,222.397979736328,232,2.34713083779604,0.830033020517578 +-153.42914,58.1134984,13.719616,33546.0211267251,901547.779895002,205.739669799805,132,2.31331803848178,0.707215282274426 +-153.36612,58.1131977,12.90710714,37249.5426390629,901547.776628618,50.168830871582,35,1.70043398039915,-1.51895455120804 +-153.17704,58.1121068,9.896225027,48361.7117375911,901547.778490026,72.0088424682617,35,1.85738582975597,-0.948860635826227 +-153.05099,58.1112222,2.621191857,55770.0530675015,901547.780129991,16.8377685546875,35,1.22628453558412,-3.24120067050157 +-152.6099,58.1071353,8.741579416,81697.7665856126,901547.770798671,61.1764450073242,30,1.78658423632044,-1.20603223197076 +-152.48389,58.1056846,12.9586031,89105.9849751364,901547.778253226,55.7289085388184,30,1.74608053740018,-1.35315322735583 +-152.42089,58.1049121,13.49439377,92810.0375498555,901547.782739221,46.3891448974609,30,1.66641636713534,-1.64251623217571 +-152.3579,58.1041081,11.89372753,96513.669684235,901547.770373733,35.220516204834,30,1.54679571685749,-2.07701257711766 +-152.2949,58.1032727,13.57198764,100218.063017421,901547.78124426,88.1562118530273,30,1.94525291990751,-0.629702284631387 +-152.23191,58.1024059,13.719616,103922.048940466,901547.786153799,176.998077392578,30,2.24796854894752,0.46984728368465 +-152.16893,58.1015076,13.719616,107625.634402853,901547.77270361,205.594985961914,130,2.31301251890482,0.706105547966953 +-152.10594,58.1005779,13.719616,111330.001009662,901547.784374814,93.263542175293,130,1.96971190605703,-0.540860265646637 +-152.04296,58.0996167,13.719616,115033.980478754,901547.777504761,71.1735458374023,30,1.85231860274216,-0.967266250670944 +-151.97999,58.0986242,13.719616,118737.578801393,901547.773245483,62.2000007629395,30,1.79379039001783,-1.1798574249008 +-151.91701,58.0976002,13.719616,122441.97853588,901547.784969825,68.8113784790039,30,1.83766025803282,-1.02050954256338 +-151.85404,58.0965448,13.719616,126146.010739094,901547.78805123,93.7654495239258,30,1.97204284002847,-0.532393648147565 +-151.79108,58.0954579,13.719616,129849.682418891,901547.770188913,121.909111022949,130,2.08603616434789,-0.118337357285359 +-151.72812,58.0943397,13.719616,133553.587103761,901547.772706325,157.876510620117,130,2.19831751907149,0.289500571360083 +-151.66516,58.09319,13.719616,137257.732181733,901547.773842294,150.601608276367,130,2.17782960972539,0.215082636783491 +-151.60221,58.0920089,13.719616,140961.536289038,901547.764123353,155.013442993164,130,2.190369362458,0.260630597910109 +-151.53926,58.0907964,13.719616,144665.593683606,901547.764261869,142.420349121094,130,2.15357204603972,0.126972241679171 +-151.47631,58.0895525,13.719616,148369.91099669,901547.774876008,134.762954711914,130,2.12957052442998,0.0397918644762705 +-151.41337,58.0882773,13.719616,152073.906797818,901547.784864597,115.114837646484,130,2.06113130532122,-0.208798913824713 +-151.35044,58.0869706,13.719616,155777.5885755,901547.770876888,138.752456665039,130,2.14224068121183,0.0858134903307423 +-151.28751,58.0856325,13.719616,159481.550158763,901547.767083989,139.357482910156,130,2.14413029346079,0.0926771013679887 +-151.22458,58.084263,13.719616,163185.798174308,901547.774167786,121.09903717041,130,2.08314069018483,-0.128854545896184 +-151.16166,58.0828622,13.719616,166889.751144687,901547.778858079,109.46321105957,130,2.03926818384849,-0.288212011369801 +-151.09874,58.0814299,13.719616,170594.004263847,901547.783558916,112.065010070801,130,2.049470034493,-0.251155977930863 +-151.03583,58.0799663,13.719616,174297.975563933,901547.785077715,100.107398986816,31,2.00046617758315,-0.429151973320747 +-150.97293,58.0784713,13.719616,178001.67214398,901547.771325006,130.83381652832,130,2.11672001029941,-0.00688487074786884 +-150.91003,58.0769449,13.719616,181705.688249957,901547.76874975,150.838989257812,130,2.17851361362204,0.217567134170279 +-150.84713,58.0753872,13.719616,185410.02997071,901547.789288586,157.96369934082,130,2.19855729589568,0.290371509224647 +-150.78425,58.0737981,13.719616,189113.529181744,901547.765621824,157.353668212891,130,2.19687687159654,0.28426772852932 +-150.72136,58.0721776,13.719616,192817.955376106,901547.782314018,156.857986450195,130,2.19550663577173,0.279290640909355 +-150.65849,58.0705258,13.719616,196521.551729937,901547.764245827,136.591186523438,130,2.13542267761987,0.0610485552327564 +-150.59562,58.0688426,13.719616,200225.500648551,901547.75805168,142.426574707031,130,2.15359102983343,0.127041196236421 +-150.53275,58.0671281,13.719616,203929.808160824,901547.775744744,173.286209106445,130,2.23876400098689,0.436413738252112 +-150.46989,58.0653822,13.719616,207633.893813398,901547.775774755,184.740203857422,130,2.26656141852309,0.537381892916453 +-150.40704,58.0636051,13.719616,211337.763006858,901547.779667639,175.240737915039,130,2.2436350732653,0.454106863109715 +-150.34419,58.0617965,13.719616,215042.011754749,901547.785566501,191.319869995117,130,2.28176007709005,0.592587758960687 +-150.28135,58.0599567,13.719616,218746.057193103,901547.794917567,214.119201660156,230,2.33065561545474,0.770190310477352 +-150.21852,58.0580855,13.719616,222449.907134207,901547.784672304,239.370330810547,230,2.3790703199895,0.946046336280054 +-150.1557,58.056183,13.719616,226153.567534114,901547.765261933,282.555053710938,230,2.45110307938881,1.20768987861484 +-150.09288,58.0542492,13.719616,229857.63258748,901547.770589895,321.964324951172,230,2.50780775264245,1.41365743699717 +-150.03007,58.052284,13.719616,233561.521903497,901547.755316344,309.976531982422,230,2.49132881507189,1.35380123218382 +-149.96726,58.0502876,13.719616,237265.828349087,901547.776795801,295.646789550781,230,2.4707731673265,1.27913725240658 +-149.90446,58.0482599,13.719616,240969.971519415,901547.788603748,271.038208007812,230,2.43303051728516,1.1420451746316 +-149.84167,58.0462009,13.719616,244673.957976577,901547.790095078,242.645065307617,230,2.38497146345899,0.967480973715314 +-149.77889,58.0441106,13.719616,248377.794280868,901547.780640427,210.464157104492,134,2.32317814436567,0.743030001199111 +-149.71611,58.041989,13.719616,252082.074616337,901547.797583908,167.885269165039,134,2.2250125913078,0.386464693254534 +-149.65335,58.0398361,13.719616,255785.630288383,901547.764969567,155.92057800293,230,2.19290343605709,0.26983507651861 +-149.59059,58.037652,13.719616,259489.642361702,901547.769835402,180.300811767578,134,2.255997682049,0.499011386851991 +-149.52784,58.0354366,13.719616,263193.530483616,901547.762508451,189.549697875977,134,2.27772309653929,0.577924293331371 +-149.46509,58.0331899,13.719616,266897.888830568,901547.782626355,194.926391601562,134,2.28987064338122,0.622047650716327 +-149.40236,58.030912,13.719616,270601.547927445,901547.760978637,211.935119628906,230,2.32620292932641,0.754016883536125 +-149.33963,58.0286028,13.719616,274305.690324049,901547.766834426,266.637390136719,230,2.425921049772,1.11622155937975 +-149.27691,58.0262624,13.719616,278009.7341458,901547.770643937,187.140380859375,131,2.27216750899756,0.557744813657259 +-149.2142,58.0238908,13.719616,281713.685903929,901547.771916165,151.812835693359,131,2.18130849247601,0.227718931905737 +-149.1515,58.0214879,13.719616,285417.552922474,901547.759033986,137.476699829102,131,2.13822909821633,0.0712422758712899 +-149.0888,58.0190538,13.719616,289121.928540264,901547.786215891,131.76155090332,134,2.11978869806812,0.0042614791187702 +-149.02612,58.0165885,13.719616,292825.644011039,901547.766504838,144.983596801758,134,2.16131886967321,0.155110916279607 +-148.96344,58.014092,13.719616,296529.881088786,901547.787100043,218.497848510742,134,2.33944716494711,0.802123727591714 +-148.90077,58.0115642,13.719616,300234.059505444,901547.792914465,306.798522949219,330,2.48685326441466,1.33754475474744 +-148.83812,58.0090053,13.719616,303937.596430481,901547.760061701,698.633728027344,330,2.84424954829644,2.63571006886153 +-148.77547,58.0064152,13.719616,307641.674457689,901547.767994584,697.363647460938,430,2.8434593044988,2.63283967783045 +-135.98309,56.7879338,13.719616,1085481.94800676,901547.819486809,460.520538330078,351,2.6632490036632,1.9782644280547 +-135.9246,56.7790241,13.719616,1089185.80585718,901547.780448103,219.465057373047,250,2.34136538290116,0.809091242714727 +-135.86614,56.7700861,13.719616,1092889.59159777,901547.714244677,204.98876953125,250,2.31173006854742,0.701447322221073 +-135.8077,56.76112,13.719616,1096593.89150686,901547.806297629,190.386322021484,150,2.27963574402759,0.584871574932838 +-135.7493,56.7521256,13.719616,1100297.5410163,901547.704249981,166.23583984375,150,2.22072466185705,0.370889709592504 +-135.69092,56.7431031,13.719616,1104001.71398067,901547.759210202,159.781311035156,150,2.20352598030361,0.308419189197965 +-135.63257,56.7340523,13.719616,1107705.83348339,901547.783415243,147.188018798828,150,2.16787245958485,0.178915425419445 +-135.57425,56.7249735,13.719616,1111409.89502241,901547.807909555,129.944030761719,150,2.11375633411183,-0.0176497885785501 +-135.51596,56.7158665,13.719616,1115113.90930445,901547.810073306,110.353454589844,150,2.04278593320064,-0.27543454165716 +-135.4577,56.7067314,13.719616,1118817.87788092,901547.799493683,72.7762680053711,150,1.86198978103546,-0.932137770680596 +-135.39947,56.6975682,13.719616,1122521.80534403,901547.775033327,223.416000366211,150,2.34911427272731,0.837237422316637 +-135.34127,56.688377,13.71768426,1126225.69318657,901547.74628347,48.117130279541,50,1.6822997179836,-1.58482336833515 +-135.2831,56.6791577,13.71942865,1129929.54906386,901547.701399568,53.0269432067871,50,1.72449659248368,-1.43155227596377 +-135.22495,56.6699104,11.0641693,1133633.96206377,901547.820684677,16.4771919250488,50,1.21688320036063,-3.27534900344151 +-135.16684,56.6606351,10.88766858,1137337.76147573,901547.762187443,21.036958694458,50,1.32298295422289,-2.88996441352905 +-134.99268,56.6326414,7.521513855,1148449.63058171,901547.724221117,22.377311706543,50,1.34980791145325,-2.7925285122633 +-154.50021,58.0806431,10.53871733,-29422.0751063008,897843.775159293,30.9615440368652,20,1.49082261060161,-2.28032287535414 +-154.37427,58.0810797,13.42029646,-22014.1708032986,897843.779809964,102.349731445312,20,2.01008670745801,-0.394207462842648 +-154.24833,58.0813905,13.719616,-14606.4248802658,897843.778796129,212.082626342773,20,2.32650509288003,0.755114427808938 +-154.18535,58.0814987,13.719616,-10902.0064749758,897843.771521951,282.483154296875,232,2.45099255405263,1.20728841904675 +-154.12238,58.0815755,13.719616,-7198.19583930403,897843.770398946,250.190185546875,232,2.39827026920058,1.01578603202583 +-154.05941,58.0816209,13.719616,-3494.39814121475,897843.77318857,216.842163085938,232,2.33614373088858,0.790124712197177 +-153.99643,58.0816349,13.719616,209.981451388405,897843.779899252,205.447845458984,232,2.31270159115554,0.70497616963394 +-153.93346,58.0816174,13.719616,3913.77323180193,897843.779846434,197.923034667969,232,2.29649634118485,0.646114076301549 +-153.87049,58.0815684,13.719616,7617.57206392749,897843.772512939,195.602035522461,232,2.29137336993815,0.627505982491964 +-153.80751,58.0814881,13.719616,11321.9727468701,897843.781972432,194.706527709961,232,2.28938051187387,0.620267353184183 +-153.74454,58.0813762,13.719616,15025.8056597921,897843.77189831,195.96403503418,121,2.29217637329826,0.630422719895856 +-153.68157,58.081233,13.719616,18729.6655374918,897843.777010439,197.80485534668,232,2.29623694764736,0.645171884935107 +-153.6186,58.0810583,13.719616,22433.5591250066,897843.775038205,238.836730957031,232,2.37810111820796,0.942525918771774 +-153.55562,58.0808522,13.719616,26138.0812110468,897843.781178376,195.359161376953,121,2.29083378229827,0.625546046170275 +-153.49265,58.0806146,13.719616,29842.0621624667,897843.777050679,139.279724121094,121,2.14388789787948,0.0917966514300966 +-153.42969,58.0803456,12.56436051,33545.5085630828,897843.772274914,35.2507476806641,35,1.54716833296268,-2.07565912906841 +-152.61122,58.0739884,12.46665654,81697.6349854773,897843.768632703,34.1309852600098,30,1.53314882524932,-2.12658198264921 +-152.54827,58.0732795,13.07695424,85401.9429471877,897843.78466427,35.2493286132812,30,1.54715084948844,-2.07572263403713 +-152.48533,58.0725391,13.719616,89105.8163531629,897843.782023679,174.784576416016,30,2.24250310637075,0.449995236253201 +-152.42239,58.0717672,13.719616,92809.8500594751,897843.773390973,195.127487182617,30,2.29031845181834,0.623674218777193 +-152.35945,58.070964,13.719616,96514.0501862794,897843.781497402,153.881423950195,30,2.18718619642118,0.249068430298328 +-152.29652,58.0701294,13.719616,100217.835444615,897843.780492873,177.168106079102,30,2.2483855426044,0.471361923668294 +-152.23359,58.0692633,13.719616,103921.800953801,897843.773610024,52.9718780517578,130,1.72404537057684,-1.43319124272098 +-152.17066,58.0683659,13.719616,107625.952768293,897843.783626367,123.756378173828,130,2.09256759091321,-0.0946133517453591 +-152.10774,58.067437,13.719616,111329.709946881,897843.771900059,169.121231079102,130,2.22819813132165,0.398035483828476 +-152.04482,58.0664768,13.719616,115033.66668343,897843.776887685,146.176300048828,130,2.16487696501332,0.168034934136381 +-151.9819,58.0654851,13.719616,118737.830260726,897843.776744275,125.066497802734,130,2.09714098860631,-0.0780014659463621 +-151.91899,58.0644621,13.719616,122441.618461924,897843.775871836,131.32746887207,130,2.11835557400923,-0.000944036517455331 +-151.85608,58.0634076,13.719616,126145.626793699,897843.769780129,147.371170043945,130,2.16841253158648,0.180877121081268 +-151.79317,58.0623218,13.719616,129849.861178391,897843.781338679,168.524047851562,130,2.22666188208598,0.392455388115346 +-151.73027,58.0612045,13.719616,133553.740796431,897843.768658836,162.911727905273,130,2.21195235000038,0.339026169062011 +-151.66737,58.0600559,13.719616,137257.859709252,897843.773635324,157.414184570312,130,2.1970438640018,0.284874292609593 +-151.60448,58.058876,13.719616,140961.636331805,897843.775626362,146.931015014648,130,2.16711347875822,0.176158590422442 +-151.54159,58.0576646,13.719616,144665.666271594,897843.773013674,117.522354125977,130,2.07012048235403,-0.176147657074974 +-151.4787,58.0564218,13.719616,148369.955764205,897843.777579025,120.445785522461,130,2.08079160834963,-0.137387081616358 +-151.41582,58.0551477,13.719616,152073.922818494,897843.778219624,116.810356140137,130,2.06748134804295,-0.185733746176747 +-151.35295,58.0538422,13.719616,155777.574473606,897843.762746842,111.631767272949,130,2.04778780022999,-0.257266332931573 +-151.29008,58.0525054,13.719616,159481.505081667,897843.765328794,95.8764724731445,130,1.98171204691324,-0.497272328875685 +-151.22721,58.0511372,13.719616,163185.721700631,897843.775482645,91.3324813842773,31,1.96062525702226,-0.573865568528759 +-151.16435,58.0497376,13.719616,166889.64276931,897843.768774971,92.8902359008789,130,1.96797006579957,-0.547187126632458 +-151.10149,58.0483067,13.719616,170593.862604519,897843.78109336,98.7309036254883,31,1.99445311187241,-0.45099314428197 +-151.03864,58.0468444,13.719616,174297.800108874,897843.775758667,93.752555847168,31,1.97198311613513,-0.532610582375077 +-150.97579,58.0453508,13.719616,178002.049575515,897843.789804773,107.529884338379,31,2.03152917866652,-0.31632228712271 +-150.91295,58.0438258,13.719616,181706.029925588,897843.785469638,130.659423828125,130,2.11614073873962,-0.0089889503935834 +-150.85012,58.0422695,13.719616,185409.747245116,897843.77301481,149.499450683594,130,2.17463959690445,0.203495599697527 +-150.78729,58.0406819,13.719616,189113.796300092,897843.780033297,152.689361572266,130,2.18380877922138,0.236800687017818 +-150.72447,58.0390629,13.719616,192817.596039224,897843.76713888,144.928527832031,130,2.16115388071324,0.154511629284435 +-150.66165,58.0374126,13.719616,196521.740696015,897843.774230677,133.317169189453,130,2.12488608342795,0.0227766376842958 +-150.59884,58.035731,13.719616,200225.648665514,897843.771996607,138.824844360352,130,2.14246719524759,0.0866362539621467 +-150.53603,58.034018,13.719616,203929.915290407,897843.779167392,162.537445068359,130,2.2109534287807,0.335397802071613 +-150.47323,58.0322738,13.719616,207633.957808438,897843.78766026,178.388137817383,130,2.25136597194742,0.482187693741369 +-150.41044,58.0304982,13.719616,211337.783968907,897843.774374492,181.932693481445,130,2.25991074921609,0.513224763703405 +-150.34765,58.0286913,13.719616,215041.987945021,897843.782074081,185.606170654297,130,2.26859241065743,0.544759036051234 +-150.28487,58.0268532,13.719616,218745.987499548,897843.789890969,196.017135620117,130,2.29229403860122,0.630850113861222 +-150.2221,58.0249837,13.719616,222449.790440307,897843.774775196,201.864242553711,130,2.30505939652202,0.677217537425464 +-150.15933,58.023083,13.719616,226153.990258317,897843.792362168,235.112274169922,230,2.37127530230708,0.917732607137961 +-150.09657,58.0211509,13.719616,229858.006616919,897843.786697596,279.864166259766,230,2.44694729506527,1.1925948837728 +-150.03382,58.0191876,13.719616,233561.844778274,897843.779392159,291.177062988281,230,2.46415716112878,1.25510602950029 +-149.97108,58.017193,13.719616,237265.511950469,897843.758614548,272.919952392578,230,2.43603528685071,1.15295935534031 +-149.90834,58.0151671,13.719616,240969.602877482,897843.759986455,258.865997314453,230,2.41307500853254,1.06956107097282 +-149.84561,58.01311,13.719616,244673.535236457,897843.75884109,229.045639038086,230,2.35992202735102,0.876494271950275 +-149.78288,58.0110216,13.719616,248377.904445098,897843.780796107,175.424591064453,134,2.24409047281004,0.455761004240194 +-149.72017,58.008902,13.719616,252081.539972523,897843.762141366,141.449249267578,134,2.15060064681024,0.116179271555887 +-149.65746,58.0067511,13.719616,255785.625437156,897843.766484906,134.57568359375,134,2.12896659454561,0.0375982187574723 +-149.59476,58.004569,13.719616,259489.578466655,897843.766988749,136.317001342773,134,2.13455002405841,0.0578788284174035 +-149.53206,58.0023556,13.719616,263193.994513363,897843.791566728,157.158645629883,134,2.19633827746986,0.282311400931149 +-149.46938,58.000111,13.719616,266897.702996718,897843.772106371,176.606079101562,230,2.24700564870262,0.46634975515607 +-149.4067,57.9978352,13.719616,270601.8867975,897843.787887404,222.603775024414,230,2.34753252504079,0.831492063243459 +-149.34403,57.9955281,13.719616,274305.965027049,897843.787610524,262.004333496094,230,2.41830847451775,1.08857051321099 +-149.28137,57.9931898,13.719616,278009.94343395,897843.781912035,222.812408447266,230,2.34793937308212,0.832969851455568 +-149.21872,57.9908204,13.719616,281713.827722699,897843.781440724,140.501525878906,131,2.14768104080473,0.105574429205382 +-149.15608,57.9884197,13.719616,285417.625995933,897843.763433428,157.111480712891,131,2.19620792169229,0.281837911539778 +-149.09344,57.9859878,13.719616,289121.932147841,897843.782105893,254.708602905273,134,2.40604361371584,1.04402103803867 +-149.03082,57.9835248,13.719616,292825.575478437,897843.761638374,227.250366210938,231,2.35650459175434,0.864081170429888 +-148.9682,57.9810305,13.719616,296529.740513729,897843.766947021,279.640747070312,330,2.44660045369185,1.19133505690614 +-148.90559,57.9785051,13.719616,300233.843887164,897843.776359465,454.442962646484,330,2.65747938247033,1.95730751706836 +-148.84299,57.9759485,13.719616,303937.892929109,897843.778335299,699.7646484375,430,2.84495199848366,2.63826156844077 +-135.99935,56.7559511,12.16564308,1085481.91420123,897843.809885875,652.362609863281,450,2.8144890615108,2.52761148636744 +-135.94091,56.7470489,13.719616,1089185.62467431,897843.726817608,272.269226074219,250,2.43499855686906,1.14919365613472 +-135.88249,56.7381185,13.719616,1092889.84439068,897843.788305791,230.455230712891,250,2.36258656988716,0.88617265097767 +-135.8241,56.7291599,13.719616,1096593.98982799,897843.829701319,204.277328491211,250,2.31022016958143,0.695962938208524 +-135.76574,56.7201731,13.719616,1100298.06564145,897843.849813251,184.993240356445,150,2.26715585959475,0.539541072559082 +-135.70741,56.7111582,13.719616,1104002.07344592,897843.858196622,168.86686706543,150,2.22754444612388,0.395661112609875 +-135.64911,56.7021151,13.719616,1107706.02090064,897843.842936645,156.850463867188,150,2.19548580741159,0.279214986360333 +-135.59084,56.6930439,13.719616,1111409.90959001,897843.813601143,142.103469848633,150,2.15260468255601,0.123458501393304 +-135.5326,56.6839445,13.719616,1115113.74718036,897843.758299161,116.149147033691,150,2.06501602481278,-0.194688503822019 +-135.47439,56.6748171,13.719616,1118817.53215355,897843.697336721,103.811630249023,150,2.01624601121984,-0.371835113539334 +-135.4162,56.6656617,13.719616,1122521.85725678,897843.798587278,77.0633087158203,50,1.88684765152586,-0.841846889916823 +-135.35805,56.6564782,13.719616,1126225.55377216,897843.712692047,80.4744338989258,50,1.90565793030406,-0.773522588406301 +-135.29992,56.6472666,13.719616,1129929.8026466,897843.777134947,60.2122001647949,50,1.7796844966968,-1.23109405566558 +-135.24182,56.6380271,13.719616,1133634.01405218,897843.843200713,49.5012741088867,50,1.69461637734443,-1.54008574601202 +-135.18376,56.6287595,13.63669456,1137337.61055554,897843.717083474,42.7887077331543,50,1.63132917050275,-1.76996294522827 +-135.00973,56.6007893,10.58539025,1148450.01213704,897843.842758063,40.0785369873047,50,1.60291185981684,-1.87318272874746 +-154.68846,58.0465994,12.47288654,-40533.920149336,894139.774477445,17.1609210968018,20,1.23454059449885,-3.21121230800946 +-154.43683,58.047723,13.11691893,-25718.3472881467,894139.780711345,15.8929853439331,20,1.20120548289774,-3.33229494813281 +-154.37392,58.0479253,13.719616,-22014.4389524017,894139.772378367,154.493606567383,121,2.18891051165756,0.255331635405455 +-154.311,58.0480963,13.719616,-18309.9813135925,894139.773351819,231.507858276367,121,2.36456573724659,0.893361551737732 +-154.24809,58.0482359,13.719616,-14606.1452823946,894139.778445058,273.280212402344,232,2.43660818655696,1.15504029059523 +-154.18518,58.048344,13.719616,-10902.3355037853,894139.77310051,253.153137207031,232,2.4033833137622,1.03435806928185 +-154.12226,58.0484208,13.719616,-7197.95651859703,894139.778522371,227.837890625,232,2.35762595117831,0.868154267925578 +-154.05935,58.0484661,13.719616,-3494.17921540626,894139.775053747,208.542419433594,232,2.31919440776135,0.7285599327806 +-153.99644,58.04848,13.719616,209.59182335771,894139.772201572,201.045700073242,232,2.30329478893143,0.670807978987289 +-153.93352,58.0484625,13.719616,3913.95198414466,894139.770548084,197.680908203125,232,2.29596472767275,0.644183104288011 +-153.87061,58.0484137,13.719616,7617.73040840471,894139.780652938,195.520492553711,121,2.29119228263513,0.626848221719945 +-153.8077,58.0483334,13.719616,11321.5225155039,894139.780229293,194.818511962891,121,2.28963022185138,0.621174371096806 +-153.74478,58.0482216,13.719616,15025.9237235538,894139.771580697,195.908935546875,121,2.29205424492888,0.629979114799375 +-153.68187,58.0480785,13.719616,18729.7631203155,894139.773139965,206.148635864258,121,2.3141804653145,0.710347862691997 +-153.61896,58.047904,13.719616,22433.6361242985,894139.77551321,213.306030273438,121,2.32900313335594,0.764188023829169 +-153.55605,58.0476981,13.719616,26137.5493804443,894139.778789353,112.668342590332,121,2.05180190566734,-0.242685956243368 +-153.49314,58.0474607,13.719616,29841.5096187856,894139.771902002,115.603416442871,35,2.06297066903574,-0.202117819806909 +-153.43023,58.047192,12.71588836,33545.5233239563,894139.777314843,51.879093170166,35,1.71499237615077,-1.46607430245832 +-152.73831,58.0421631,10.45859554,74289.8109137152,894139.771921995,34.556324005127,30,1.53852753736012,-2.10704496502552 +-152.61253,58.0408406,13.70967316,81697.9449812414,894139.774093116,31.513765335083,30,1.49850029674914,-2.25243532783651 +-152.54965,58.0401323,13.719616,85401.6396418957,894139.771136861,84.8594818115234,30,1.92870037544989,-0.689825850668034 +-152.48676,58.0393926,13.719616,89106.0762108662,894139.783113417,201.626281738281,30,2.30454714121583,0.67535687994118 +-152.42388,58.0386215,13.719616,92810.083843588,894139.784122588,114.704513549805,30,2.05958050744972,-0.214431854335793 +-152.36101,58.037819,13.719616,96513.6691769731,894139.772883818,195.930725097656,30,2.29210254571427,0.630154557038312 +-152.29813,58.0369851,13.719616,100218.01632938,894139.778313604,57.6943626403809,130,1.76113337998792,-1.29847700656811 +-152.23526,58.0361199,13.719616,103921.954157306,894139.7823808,134.544357299805,130,2.12886548846213,0.0372309726037232 +-152.17239,58.0352233,13.719616,107626.078312233,894139.788890545,127.820816040039,130,2.10660158586591,-0.0436378763761917 +-152.10953,58.0342953,13.719616,111329.80668702,894139.781535513,156.769485473633,130,2.19526153296521,0.278400357556788 +-152.04667,58.0333359,13.719616,115033.734655858,894139.776436393,160.35188293457,130,2.20507406400436,0.314042271066158 +-151.98381,58.0323451,13.719616,118737.868851027,894139.774081516,129.529235839844,130,2.11236780340495,-0.0226933284320779 +-151.92096,58.031323,13.719616,122441.626813179,894139.767704245,163.845489501953,130,2.21443449020191,0.348042010747322 +-151.85811,58.0302696,13.719616,126145.603882197,894139.775145219,153.286911010742,130,2.18550507254194,0.242962108528402 +-151.79526,58.0291847,13.719616,129849.807397579,894139.774608767,146.930252075195,130,2.1671112236778,0.1761503993267 +-151.73242,58.0280685,13.719616,133553.654515831,894139.76886777,140.041717529297,130,2.14625742849204,0.100403462946266 +-151.66958,58.026921,13.719616,137257.740573982,894139.777483734,124.17268371582,130,2.09402606752919,-0.0893157483854661 +-151.60674,58.0257421,13.719616,140962.072569478,894139.789875107,106.714317321777,130,2.02822269043394,-0.328332396149153 +-151.54391,58.0245318,13.719616,144666.068386849,894139.784858159,87.4446029663086,31,1.94173301022085,-0.642487601295576 +-151.48109,58.0232902,13.719616,148369.734227008,894139.772538697,104.080711364746,31,2.01737025185415,-0.367751550665329 +-151.41827,58.0220173,13.719616,152073.665422794,894139.774772619,92.01025390625,31,1.96383622915809,-0.562202401228748 +-151.35545,58.020713,13.719616,155777.869009594,894139.781043405,75.8426742553711,31,1.87991363806781,-0.867033205960957 +-151.29264,58.0193774,13.719616,159481.762412213,894139.779162061,71.4023513793945,31,1.85371251393697,-0.962203167349522 +-151.22983,58.0180104,13.719616,163185.941425912,894139.781543489,79.5245590209961,31,1.90050126953949,-0.792253052160754 +-151.16703,58.0166121,13.719616,166889.823452003,894139.774914015,80.9578323364258,31,1.90825887132216,-0.764075228246107 +-151.10423,58.0151825,13.719616,170594.003817469,894139.783997371,84.9472732543945,31,1.92914944289222,-0.688194709540864 +-151.04144,58.0137216,13.719616,174297.900365883,894139.783273432,83.0141525268555,31,1.9191521386455,-0.724507772079684 +-150.97866,58.0122293,13.719616,178001.520188675,894139.760650168,95.2862548828125,31,1.97903025783587,-0.507013352263506 +-150.91587,58.0107058,13.719616,181706.046344485,894139.792252734,118.188140869141,130,2.07257390113508,-0.167236139786745 +-150.8531,58.0091509,13.719616,185409.720217478,894139.774452296,132.749008178711,130,2.12303128497669,0.0160394802971615 +-150.79033,58.0075647,13.719616,189113.725361104,894139.772803043,141.686264038086,130,2.15132774903632,0.118820314376681 +-150.72756,58.0059472,13.719616,192818.068353326,894139.788109091,130.670364379883,130,2.11617710215072,-0.00885686810533015 +-150.66481,58.0042984,13.719616,196521.578288539,894139.762006823,127.866455078125,130,2.10675662512558,-0.0430747295324611 +-150.60205,58.0026183,13.719616,200226.02796507,894139.782433831,135.257614135742,130,2.13116172245928,0.0455715498917981 +-150.53931,58.000907,13.719616,203929.657151443,894139.770949139,156.922836303711,130,2.19568614918933,0.279942684880312 +-150.47657,57.9991643,13.719616,207633.651055141,894139.765290566,165.395385742188,130,2.21852338928751,0.362894059314204 +-150.41383,57.9973904,13.719616,211338.015072481,894139.788652501,173.342544555664,130,2.23890516743479,0.436926495083788 +-150.35111,57.9955852,13.719616,215041.578872225,894139.766016506,182.075210571289,130,2.26025082089129,0.514460001093851 +-150.28839,57.9937487,13.719616,218745.526503986,894139.760826697,189.543395996094,130,2.27770865749145,0.577871846588305 +-150.22567,57.991881,13.719616,222449.863899058,894139.785166123,193.548599243164,130,2.28679003257481,0.610857992973582 +-150.16296,57.9899819,13.719616,226154.010139146,894139.783619884,219.660919189453,230,2.34175279661049,0.810498439885893 +-150.10026,57.9880517,13.719616,229857.969851562,894139.788933554,245.383590698242,230,2.38984551720321,0.985184928107737 +-150.03757,57.9860902,13.719616,233561.75086626,894139.778104568,268.296661376953,230,2.42861526844314,1.12600773059987 +-149.97488,57.9840974,13.719616,237265.948483451,894139.786179171,272.249389648438,230,2.43496691479103,1.1490787230758 +-149.9122,57.9820734,13.719616,240969.979832273,894139.789030944,267.875610351562,230,2.4279331735861,1.12353016738986 +-149.84953,57.9800181,13.719616,244673.852134477,894139.774859277,247.568389892578,230,2.39369519215904,0.999168046353955 +-149.78687,57.9779317,13.719616,248377.570527439,894139.765327643,187.005767822266,230,2.2718550016956,0.556609697938081 +-149.72421,57.975814,13.719616,252081.731678587,894139.775475852,125.272018432617,134,2.09785407500525,-0.0754113326103185 +-149.66156,57.973665,13.719616,255785.753396987,894139.767859068,121.928161621094,134,2.08610402575052,-0.118090865301422 +-149.59892,57.9714849,13.719616,259489.640751367,894139.764183342,122.693603515625,134,2.08882192189343,-0.108218690745581 +-149.53628,57.9692736,13.719616,263193.989716346,894139.792358323,140.657943725586,230,2.14816426418532,0.107329634449342 +-149.47366,57.967031,13.719616,266897.630083447,894139.761976754,189.492599487305,330,2.2775922535411,0.577449034215647 +-149.41104,57.9647573,13.719616,270601.744334692,894139.774606748,258.526733398438,330,2.41250545871475,1.0674923034689 +-149.34843,57.9624523,13.719616,274305.751770025,894139.767801138,332.522918701172,330,2.52182158384192,1.46455967185928 +-149.28583,57.9601162,13.719616,278009.657343298,894139.763336304,326.048919677734,330,2.51328276556548,1.43354424665789 +-149.22323,57.9577489,13.719616,281714.057071785,894139.791991785,227.057876586914,230,2.35613657207667,0.862744417917303 +-149.16065,57.9553505,13.719616,285417.779162881,894139.780146636,254.398910522461,231,2.40551524708999,1.04210185964273 +-149.09807,57.9529208,13.719616,289122.009215584,894139.79044995,384.096008300781,231,2.5844397938042,1.69200688345881 +-149.03551,57.95046,13.719616,292825.574609301,894139.758221116,453.071563720703,330,2.6561668052674,1.95253986202048 +-148.97295,57.9479681,13.719616,296529.659291198,894139.770651803,624.645202636719,330,2.79563340888132,2.4591223740781 +-136.01558,56.7239651,12.70944984,1085481.9624591,894139.824237019,582.6435546875,450,2.76540294656941,2.34931670632824 +-135.95719,56.7150704,13.719616,1089185.52073707,894139.697670636,261.303344726562,250,2.41714496880499,1.08434432836465 +-135.89882,56.7061475,13.719616,1092889.58499638,894139.712071116,231.205841064453,250,2.36399880167763,0.891302279931746 +-135.84048,56.6971965,13.719616,1096593.56814365,894139.713524894,219.351440429688,250,2.34114049066078,0.808274369907013 +-135.78216,56.6882173,13.719616,1100298.06656893,894139.85576581,199.858215332031,250,2.3007220049856,0.661462893350401 +-135.72388,56.6792099,13.719616,1104001.90743908,894139.806802972,177.568283081055,150,2.24936539549104,0.474921029030414 +-135.66563,56.6701744,13.719616,1107705.68109725,894139.741313334,164.524490356445,150,2.21623055417055,0.354565827729106 +-135.6074,56.6611108,13.719616,1111409.9808937,894139.825471243,151.462112426758,150,2.18030400959203,0.224070363363184 +-135.54921,56.6520192,13.719616,1115113.63088978,894139.734687275,135.092346191406,150,2.13063074427741,0.043642885578989 +-135.49104,56.6428994,13.719616,1118817.81927555,894139.781604523,100.846458435059,150,2.00366065109496,-0.417548733732343 +-135.4329,56.6337516,13.719616,1122521.95577254,894139.819172985,95.031982421875,50,1.97786978899216,-0.511228506334627 +-135.37479,56.6245758,13.719616,1126226.04493849,894139.846241679,98.4006729125977,50,1.99299806836253,-0.456278277620633 +-135.31672,56.615372,13.719616,1129929.50258426,894139.691526728,85.0677719116211,50,1.92976505794702,-0.685958619947819 +-135.25867,56.6061402,13.719616,1133633.51073809,894139.693620895,81.8100357055664,50,1.91280658220691,-0.747556644266764 +-135.20064,56.5968804,13.719616,1137338.07394019,894139.853073145,74.8584289550781,50,1.87424070838754,-0.887638905775023 +-135.14265,56.5875927,12.72132211,1141042.01611748,894139.837520235,50.5079231262207,50,1.70335951079376,-1.50832818978534 +-135.08469,56.5782771,13.64305742,1144745.93051156,894139.81654661,268.707824707031,50,2.42928031316785,1.12842336286268 +-154.87635,58.0122741,11.87566208,-51646.1992685549,890435.781330291,20.5440845489502,20,1.31268679372652,-2.92736300726864 +-154.68781,58.0134454,13.719616,-40534.0110641359,890435.773291988,15.2977247238159,20,1.18462684170829,-3.3925133049482 +-154.62497,58.0137731,12.98913995,-36830.4952152177,890435.777836331,30.1160678863525,20,1.47879826743778,-2.32399872181439 +-154.56212,58.0140694,12.33217247,-33126.4560595005,890435.774397488,23.4337596893311,121,1.36984197196614,-2.71975908619032 +-154.49927,58.0143344,13.66846409,-29422.4761710982,890435.780099258,27.7450180053711,121,1.44318501098946,-2.45335623427009 +-154.43641,58.014568,13.719616,-25717.959715361,890435.779763303,103.787467956543,121,2.01614491684677,-0.372202317157541 +-154.37356,58.0147701,13.719616,-22014.078711569,890435.770402427,272.637329101562,121,2.43558531853065,1.1513249419681 +-154.31071,58.014941,13.719616,-18310.2370310115,890435.780996997,268.118011474609,232,2.428325989743,1.12495698779261 +-154.24786,58.0150804,13.719616,-14606.4282206557,890435.777946485,253.046966552734,232,2.40320113549067,1.03369634580077 +-154.185,58.0151884,13.719616,-10902.0562771615,890435.770709474,224.098129272461,232,2.35043823114444,0.842046417183022 +-154.12215,58.0152651,13.719616,-7198.29313581497,890435.774243343,211.209213256836,232,2.32471285883967,0.748604522219827 +-154.05929,58.0153104,13.719616,-3493.95359879919,890435.774612259,202.118255615234,232,2.30560554139705,0.679201291496852 +-153.99644,58.0153243,13.719616,209.790378189142,890435.773403162,200.796020507812,232,2.30275510145792,0.668847680041385 +-153.93359,58.0153069,13.719616,3913.53472475407,890435.780696487,194.395004272461,121,2.28868509986607,0.6177414182815 +-153.87073,58.015258,13.719616,7617.87539343911,890435.77530543,193.60026550293,121,2.28690594856317,0.611279032929027 +-153.80788,58.0151778,13.719616,11321.6403956275,890435.777861187,196.245315551758,121,2.29279929877116,0.632685363014054 +-153.74502,58.0150662,13.719616,15026.0149819921,890435.780085102,213.924880981445,121,2.33026129903873,0.768758040705282 +-153.68217,58.0149232,13.719616,18729.8271966895,890435.778066601,206.728225708008,121,2.31539977721923,0.714776751556228 +-153.61932,58.0147488,13.719616,22433.6729802076,890435.773583306,183.656036376953,121,2.26400520723682,0.528097003909369 +-153.55647,58.0145431,13.719616,26137.5588994655,890435.77789511,90.3487854003906,121,1.95592231851893,-0.59094798352514 +-153.49361,58.0143059,13.719616,29842.0810332849,890435.773257907,78.3554229736328,35,1.89406905933712,-0.815616675551349 +-153.43076,58.0140374,13.719616,33546.0672654089,890435.773705323,94.9548034667969,35,1.97751693922952,-0.512510157385904 +-153.36792,58.0137376,13.719616,37249.5242050603,890435.777700527,241.774948120117,35,2.38341129877106,0.961814010253393 +-153.30507,58.0134063,13.42167745,40953.6372926271,890435.773714549,114.601905822754,35,2.05919183998236,-0.21584360551397 +-153.24222,58.0130437,13.62106333,44657.8236464774,890435.779206346,101.049415588379,35,2.00453380614943,-0.414377185351227 +-153.17938,58.0126497,12.51277756,48361.5007142143,890435.775907434,116.602554321289,35,2.06670806427797,-0.188542533528308 +-152.67667,58.0083683,13.60395068,77994.0028751588,890435.782413776,33.2784881591797,30,1.52216358808023,-2.16648349954621 +-152.61385,58.007692,13.719616,81697.5193935571,890435.77478085,102.175750732422,30,2.00934783735745,-0.39689124994238 +-152.55102,58.0069843,13.719616,85401.771537785,890435.777874498,198.150314331055,30,2.29699476560351,0.647924496054622 +-152.4882,58.0062452,13.60779774,89105.5873450486,890435.766893343,170.606857299805,30,2.23199648303089,0.411832181393967 +-152.42538,58.0054748,13.719616,92809.5624835099,890435.765683303,152.962814331055,30,2.18458586549951,0.239623286182514 +-152.36256,58.0046731,13.719616,96513.7035549904,890435.774635451,266.579833984375,30,2.42582729316277,1.11588100861421 +-152.29974,58.00384,13.719616,100218.017446599,890435.782989153,87.4206161499023,130,1.94161386311863,-0.642920377578833 +-152.23693,58.0029755,13.719616,103921.92149161,890435.775519825,90.8167724609375,130,1.95816606343907,-0.58279806154665 +-152.17412,58.0020797,13.719616,107626.011313071,890435.7783669,162.941070556641,130,2.21203056538885,0.339310269677822 +-152.11132,58.0011526,13.719616,111329.704211031,890435.775221254,176.634429931641,130,2.24707536103046,0.466602970228677 +-152.04852,58.0001941,13.719616,115033.596410582,890435.771035236,183.853515625,130,2.26447193881157,0.529792306207331 +-151.98572,57.9992043,13.719616,118737.694201843,890435.777462223,172.100875854492,130,2.23578308054142,0.42558618435474 +-151.92292,57.9981831,13.719616,122442.004530498,890435.7838387,168.686370849609,130,2.2270799948362,0.393974092965401 +-151.86013,57.9971306,13.719616,126145.944364978,890435.782854465,154.889511108398,130,2.19002200896658,0.259368910884703 +-151.79735,57.9960467,13.719616,129849.520670265,890435.762205179,138.654800415039,130,2.14193491003125,0.0847028421270681 +-151.73456,57.9949316,13.719616,133553.917907243,890435.783318224,115.692802429199,130,2.06330634112535,-0.200898562967076 +-151.67178,57.9937851,13.719616,137257.964822342,890435.784766855,106.275634765625,130,2.02643370761126,-0.33483049238766 +-151.60901,57.9926073,13.719616,140961.667636731,890435.776624388,96.6033172607422,31,1.98499203990721,-0.485358458118384 +-151.54624,57.9913981,13.719616,144665.622652461,890435.768434716,93.3274154663086,31,1.97000923899602,-0.539780267544942 +-151.48347,57.9901576,13.719616,148369.836067495,890435.771975298,74.3982391357422,31,1.87156265674641,-0.897366353727644 +-151.42071,57.9888859,13.719616,152073.724737694,890435.77613891,76.7469024658203,31,1.88506085621243,-0.848337040497346 +-151.35795,57.9875828,13.719616,155777.885406163,890435.781027811,69.797981262207,31,1.84384286188731,-0.998052560673059 +-151.2952,57.9862484,13.719616,159481.73493705,890435.774451348,75.9124908447266,31,1.88031324175341,-0.865581731316602 +-151.23245,57.9848827,13.719616,163185.869214186,890435.77998469,76.3797225952148,31,1.88297807671881,-0.855902290102645 +-151.16971,57.9834857,13.719616,166889.705522566,890435.77319016,81.1976547241211,31,1.90954348545938,-0.759409143034351 +-151.10697,57.9820574,13.719616,170593.839743596,890435.778789964,82.6165466308594,31,1.91706703752381,-0.73208145450078 +-151.04424,57.9805978,13.719616,174297.689159796,890435.771262511,87.4970626831055,31,1.94199347380025,-0.641541523231515 +-150.98151,57.9791069,13.719616,178001.849650044,890435.776477028,98.9430923461914,31,1.99538547958689,-0.447606518618757 +-150.91879,57.9775847,13.719616,181705.738494272,890435.767827956,107.218994140625,130,2.03027172863798,-0.32088970453835 +-150.85607,57.9760313,13.719616,185409.951040072,890435.783490053,115.225685119629,130,2.06154929907288,-0.207280641211369 +-150.79336,57.9744466,13.719616,189113.905072254,890435.78461422,117.189186096191,130,2.06888753800091,-0.180626062882844 +-150.73066,57.9728306,13.719616,192817.607165492,890435.770329662,115.615798950195,130,2.06301718467328,-0.201948861734466 +-150.66796,57.9711833,13.719616,196521.653191852,890435.76937303,121.81428527832,130,2.08569822141473,-0.119564862477108 +-150.60526,57.9695048,13.719616,200226.049152365,890435.793734573,141.954086303711,130,2.15214789868371,0.121799331990017 +-150.54258,57.967795,13.719616,203929.623569458,890435.771691964,153.939376831055,130,2.18734972413991,0.24966240964822 +-150.4799,57.9660539,13.719616,207633.561609603,890435.763293956,161.072341918945,130,2.207020973174,0.321114000873498 +-150.41722,57.9642816,13.719616,211337.869237754,890435.780576163,166.964920043945,130,2.22262523383204,0.377793129482906 +-150.35455,57.962478,13.719616,215041.964302169,890435.78089902,173.785217285156,130,2.24001283123502,0.440949846164953 +-150.29189,57.9606432,13.719616,218745.852743621,890435.774655091,186.560836791992,130,2.27082048104917,0.552852023668646 +-150.22924,57.9587772,13.719616,222449.541093123,890435.761097362,191.251510620117,130,2.28160487415972,0.592024017618423 +-150.16659,57.9568799,13.719616,226153.625823324,890435.762395776,216.611297607422,230,2.33568110400033,0.788444319292169 +-150.10395,57.9549514,13.719616,229857.523539728,890435.756049876,237.135040283203,230,2.37499573228799,0.93124627074507 +-150.04131,57.9529917,13.719616,233561.83006719,890435.77652855,252.707412719727,230,2.40261798135821,1.03157816354292 +-149.97868,57.9510008,13.719616,237265.962631236,890435.78909358,264.4033203125,230,2.42226690461218,1.10294866116239 +-149.91606,57.9489786,13.719616,240969.928440979,890435.781926248,268.218811035156,230,2.42848923303192,1.12554993401226 +-149.85345,57.9469253,13.719616,244673.732654743,890435.776673067,247.601821899414,230,2.39375383597793,0.999381057442774 +-149.79084,57.9448407,13.719616,248377.972473926,890435.787797599,228.612075805664,230,2.3590991670796,0.873505408576773 +-149.72824,57.9427249,13.719616,252082.06443043,890435.789542558,176.168670654297,134,2.24592867722172,0.462437887339182 +-149.66565,57.940578,13.719616,255786.014311096,890435.792448074,125.032653808594,134,2.0970234491433,-0.0784284028251373 +-149.60307,57.9383998,13.719616,259489.830076023,890435.77362833,125.343215942383,134,2.09810083324024,-0.0745150362690124 +-149.5405,57.9361905,13.719616,263193.516769237,890435.754800728,163.418716430664,134,2.21330179501808,0.343927738536243 +-149.47793,57.93395,13.719616,266897.670927799,890435.764446822,217.983993530273,230,2.33842460472069,0.79840949698158 +-149.41537,57.9316784,13.719616,270601.708990094,890435.774092585,355.960906982422,330,2.55140230467493,1.57200529310309 +-149.35282,57.9293755,13.719616,274305.638992479,890435.760920007,442.910003662109,330,2.64631548946559,1.91675707118284 +-149.29027,57.9270416,13.719616,278010.054394426,890435.799707016,443.320861816406,430,2.64671816883276,1.91821971758054 +-149.22774,57.9246764,13.719616,281713.785443151,890435.773359273,447.501831054688,430,2.65079481666941,1.93302726611437 +-149.16521,57.9222801,13.719616,285418.015642415,890435.787959807,503.058837890625,430,2.70161878322059,2.11763441923259 +-149.1027,57.9198527,13.719616,289121.572860717,890435.757641644,579.638793945312,430,2.76315744414311,2.34116040058574 +-135.97344,56.6830886,13.719616,1089185.49854623,890435.694431703,604.097900390625,450,2.78110732629336,2.40635949596189 +-135.91511,56.6741732,13.719616,1092889.99182926,890435.826840657,259.065643310547,250,2.41340982166976,1.07077720785239 +-135.85682,56.6652297,13.719616,1096593.81088567,890435.77869825,256.338012695312,250,2.40881301305006,1.0540802868858 +-135.79856,56.6562581,13.719616,1100297.54964053,890435.712797943,219.366180419922,250,2.34116967342491,0.808380370035925 +-135.74032,56.6472583,13.719616,1104001.80504213,890435.783435812,196.726943969727,150,2.29386384551162,0.636552100627302 +-135.68211,56.6382304,13.719616,1107705.98939613,890435.835037755,180.842315673828,150,2.25730005950983,0.50374199352524 +-135.62394,56.6291744,13.719616,1111409.51801262,890435.699064826,163.002487182617,150,2.21219423116129,0.339904750478183 +-135.56579,56.6200903,13.719616,1115113.57409228,890435.708488797,141.647674560547,150,2.1512094490731,0.118390615144075 +-135.50767,56.6109783,13.719616,1118817.56680065,890435.716799271,134.488861083984,150,2.12868631578759,0.0365801663088157 +-135.44958,56.6018381,13.719616,1122521.50990038,890435.690650241,112.496940612793,150,2.0511407118425,-0.245087600938684 +-135.39151,56.59267,13.719616,1126225.98804851,890435.830646677,110.138465881348,50,2.04193902289971,-0.278510761602423 +-135.33348,56.5834739,13.719616,1129929.83026552,890435.7863027,98.0809173583984,50,1.99158451918318,-0.461412691707121 +-135.27548,56.5742498,13.719616,1133633.63039608,890435.725504412,87.2289505004883,50,1.94066064727133,-0.646382729611111 +-135.2175,56.5649978,13.719616,1137337.9791659,890435.829090004,101.969924926758,50,2.00847209956254,-0.400072179573978 +-135.15956,56.5557179,13.719616,1141041.70248351,890435.7539716,72.9913330078125,50,1.86327129504726,-0.9274829460092 +-135.10164,56.54641,13.719616,1144745.98657863,890435.831392721,61.7220573425293,50,1.79044039369728,-1.19202556772121 +-155.00109,57.9781833,13.05501933,-59054.422706026,886731.773894189,15.1004314422607,20,1.17898935592339,-3.41299026241761 +-154.9383,57.9786675,13.719616,-55349.9233694002,886731.775099517,42.2098007202148,121,1.62541330177973,-1.79145106898732 +-154.87552,57.9791203,13.719616,-51646.1129236178,886731.779907333,37.6466026306152,121,1.57572578995637,-1.97193029415759 +-154.81274,57.9795417,13.719616,-47942.3948764905,886731.779195264,32.1179733276367,20,1.50674813310748,-2.22247683201615 +-154.74995,57.9799318,13.719616,-44238.1726093005,886731.777258175,25.4185314178467,20,1.40515045512634,-2.59150859730802 +-154.68716,57.9802905,13.719616,-40534.0294894765,886731.770504434,34.1039237976074,20,1.53280434924512,-2.12783321781972 +-154.62437,57.9806179,13.719616,-36829.9587752779,886731.76992224,92.9831237792969,121,1.96840413226783,-0.545610473324801 +-154.56158,57.980914,13.719616,-33125.953861364,886731.775345488,185.827133178711,121,2.26910912693133,0.546635897043571 +-154.49879,57.9811787,13.719616,-29422.0082260198,886731.775453195,225.155776977539,121,2.35248309443589,0.849473944319646 +-154.436,57.981412,13.719616,-25718.1152316915,886731.770110785,287.957092285156,232,2.4593277795229,1.23756433706499 +-154.37321,57.9816141,13.719616,-22014.268115048,886731.781541433,283.19775390625,232,2.45208980456155,1.21127394608164 +-154.31042,57.9817847,13.719616,-18310.4604581414,886731.776129953,252.346054077148,232,2.40199651808132,1.02932083153799 +-154.24762,57.981924,13.719616,-14606.0956512933,886731.773932042,223.115081787109,232,2.34852892804062,0.83511128334058 +-154.18483,57.982032,13.719616,-10902.3468010195,886731.779833499,212.378021240234,232,2.32710957009313,0.757310061581885 +-154.12203,57.9821086,13.719616,-7198.02760804843,886731.778767477,205.594009399414,232,2.31301045603004,0.706098055016934 +-154.05924,57.9821538,13.719616,-3494.31114702079,886731.773420526,200.822738647461,232,2.30281288531572,0.669057567506047 +-153.99644,57.9821677,13.719616,209.988933088869,886731.773330719,198.907424926758,121,2.29865099501249,0.65394039400296 +-153.93365,57.9821503,13.719616,3913.69952603703,886731.778985552,195.943435668945,121,2.29213071869186,0.630256889334287 +-153.87085,57.9821015,13.719616,7618.0069735064,886731.779843729,194.159057617188,121,2.28815765540954,0.61582558946773 +-153.80806,57.9820213,13.719616,11321.7382009073,886731.774193665,211.541122436523,121,2.32539480438852,0.751081543099866 +-153.74526,57.9819098,13.719616,15026.0795169544,886731.776098998,203.680221557617,121,2.30894885872316,0.691345174303059 +-153.68247,57.981767,13.719616,18729.8578152267,886731.781648935,170.133056640625,121,2.23078870468733,0.407445185715883 +-153.61968,57.9815927,13.719616,22433.6696867958,886731.770279003,130.763046264648,121,2.1164850293794,-0.00773838851957373 +-153.55689,57.9813872,13.719616,26137.5215778558,886731.775590445,50.8337287902832,35,1.70615196753566,-1.49818518985222 +-153.49409,57.9811503,12.75802502,29842.0100897327,886731.779839326,52.7009506225586,35,1.72181844911023,-1.44128005711435 +-153.4313,57.980882,13.61782083,33545.9621470727,886731.774716851,230.607849121094,35,2.36287408514413,0.887216988456031 +-153.36851,57.9805824,13.719616,37249.9741377309,886731.775465723,130.741119384766,35,2.11641219900642,-0.00800292922211613 +-153.18015,57.9794955,12.01481125,48361.8463212254,886731.773747234,49.3826866149902,35,1.69357471358955,-1.54386936609018 +-153.11737,57.9790705,13.71369264,52065.5745701549,886731.768923146,103.346580505371,35,2.01429611142081,-0.378917706166225 +-153.05458,57.9786142,11.70243014,55769.9856760589,886731.778172159,98.3566284179688,35,1.99280363307433,-0.45698452208474 +-152.9918,57.9781265,8.229376299,59473.9066993201,886731.774318409,15.6065702438354,35,1.19330747142653,-3.36098278011315 +-152.86624,57.9770572,10.71841262,66882.0740356988,886731.7853381,14.7415800094604,35,1.16854403390401,-3.45093065338371 +-152.67792,57.9752181,13.71430557,77994.0584796255,886731.784709422,76.0039138793945,30,1.88083595718155,-0.863683079683767 +-152.61516,57.9745424,13.719616,81697.5367072109,886731.77399464,137.06916809082,30,2.13693977693483,0.0665590929679516 +-152.55239,57.9738353,13.719616,85401.7509165662,886731.770713444,164.145370483398,30,2.21522863850084,0.350926584041494 +-152.48963,57.973097,13.13265257,89105.5275179533,886731.772399904,36.8136558532715,30,1.56600894806509,-2.00722463736951 +-152.42686,57.9723273,11.18301537,92810.0533211315,886731.783368854,11.881742477417,30,1.07488013532827,-3.7911446673491 +-152.36411,57.9715263,13.719616,96513.5651114229,886731.773253761,74.7168045043945,30,1.87341828967032,-0.890626165297649 +-152.30135,57.9706939,13.719616,100217.839341949,886731.773218594,203.076141357422,30,2.30765890279688,0.686659686188717 +-152.2386,57.9698303,13.719616,103921.702335805,886731.776396936,160.939010620117,130,2.20666132715408,0.319807663875947 +-152.17585,57.9689353,13.719616,107625.751127776,886731.775425046,179.570190429688,130,2.25423424320881,0.492606073648842 +-152.1131,57.968009,13.719616,111329.992027676,886731.781923931,175.066284179688,130,2.24320251384687,0.452535683837241 +-152.05036,57.9670514,13.719616,115033.841773652,886731.779041598,176.973358154297,130,2.24790789191296,0.469626960021881 +-151.98762,57.9660625,13.719616,118737.896816124,886731.783469429,191.425109863281,130,2.28199890501766,0.59345525016205 +-151.92489,57.9650422,13.719616,122441.574240533,886731.766106171,178.578109741211,130,2.25182822162278,0.483866716501465 +-151.86215,57.9639907,13.719616,126146.059664656,886731.786116258,126.457069396973,130,2.10194311295505,-0.0605587796489999 +-151.79943,57.9629078,13.719616,129849.590818564,886731.764717826,91.0535507202148,31,1.95929688618946,-0.578690590548273 +-151.7367,57.9617937,13.719616,133553.943132532,886731.781773508,94.1900100708008,31,1.97400484333221,-0.525267092136912 +-151.67398,57.9606482,13.719616,137257.944233446,886731.775855966,93.4684524536133,31,1.9706650521856,-0.537398166852685 +-151.61127,57.9594715,13.719616,140961.59993777,886731.768200652,85.4833602905273,31,1.93188158563698,-0.678270787260727 +-151.54856,57.9582635,13.719616,144665.507069932,886731.768349371,72.6959075927734,31,1.86150996299244,-0.933880606766547 +-151.48585,57.9570242,13.719616,148369.672216124,886731.776913916,71.8099746704102,31,1.85618477353816,-0.953223214824883 +-151.42315,57.9557535,13.719616,152073.51253823,886731.760460631,68.911979675293,31,1.83829472632894,-1.01820497261661 +-151.36045,57.9544516,13.719616,155777.623620657,886731.763741535,69.270263671875,31,1.84054684074818,-1.01002465022849 +-151.29775,57.9531185,13.719616,159482.012014647,886731.787414525,71.5717697143555,31,1.85474175589882,-0.95846466676918 +-151.23507,57.951754,13.719616,163185.505487066,886731.760686794,75.1319961547852,31,1.87582492760579,-0.881884569393174 +-151.17238,57.9503583,13.719616,166889.879268707,886731.778614697,80.9825134277344,31,1.9083912516971,-0.763594384939178 +-151.1097,57.9489313,13.719616,170593.960680149,886731.781041209,86.4548110961914,31,1.93678916619744,-0.660445053902167 +-151.04703,57.9474731,13.719616,174297.755802868,886731.77817499,87.1876678466797,31,1.94045506102327,-0.647129477544203 +-150.98436,57.9459835,13.719616,178001.862052723,886731.77356384,89.8287048339844,31,1.95341513799219,-0.600054778818835 +-150.9217,57.9444628,13.719616,181705.694627382,886731.774078307,92.929931640625,31,1.96815561768252,-0.54651314923179 +-150.85904,57.9429107,13.719616,185409.85147873,886731.773255324,95.5097885131836,31,1.98004788341006,-0.503317045718778 +-150.79639,57.9413275,13.719616,189113.747738584,886731.77687837,104.268135070801,130,2.01815160586369,-0.364913449882017 +-150.73374,57.9397129,13.719616,192817.981419254,886731.779634304,110.424903869629,130,2.04306702985565,-0.274413518373218 +-150.6711,57.9380672,13.719616,196521.967586609,886731.786219359,119.968658447266,130,2.07906780237067,-0.143648436955154 +-150.60847,57.9363902,13.719616,200225.713886478,886731.77347703,134.382553100586,130,2.12834288788456,0.0353327381409559 +-150.54584,57.934682,13.719616,203929.816161722,886731.78244463,144.192779541016,130,2.158943513615,0.146482945082045 +-150.48322,57.9329425,13.719616,207633.691681053,886731.771564039,152.410110473633,130,2.18301377787802,0.233913015222754 +-150.4206,57.9311718,13.719616,211337.936263275,886731.783018264,159.122467041016,130,2.20173150348738,0.301901137206753 +-150.35799,57.9293699,13.719616,215041.966582777,886731.785319927,168.52946472168,130,2.22667584139341,0.392506092304317 +-150.29539,57.9275368,13.719616,218745.789168925,886731.777704445,180.356735229492,130,2.25613236522042,0.499500594572987 +-150.23279,57.9256725,13.719616,222450.000406044,886731.792918779,185.507415771484,130,2.26836127548347,0.543919487126863 +-150.1702,57.9237769,13.719616,226154.017607556,886731.786697138,212.982070922852,230,2.3283430455655,0.761790396566466 +-150.10762,57.9218502,13.719616,229857.846020811,886731.780626279,234.991653442383,230,2.37105243704497,0.916923096893903 +-150.04504,57.9198923,13.719616,233562.082658497,886731.798020521,251.443206787109,230,2.40043990683018,1.02366677517275 +-149.98248,57.9179031,13.719616,237265.555003966,886731.757262627,263.352111816406,230,2.42053680530802,1.0966644466702 +-149.91991,57.9158828,13.719616,240970.037806074,886731.787162806,261.546875,230,2.41754953538099,1.08581382964349 +-149.85736,57.9138314,13.719616,244673.767981269,886731.779882962,255.823516845703,230,2.4079404649545,1.05091094315272 +-149.79481,57.9117487,13.719616,248377.93314069,886731.78561185,239.134857177734,230,2.37864288509355,0.944493770735906 +-149.73227,57.9096349,13.719616,252081.948538616,886731.789737116,221.699813842773,230,2.34576532844561,0.825073100801657 +-149.66974,57.9074899,13.719616,255785.821383578,886731.780500989,180.369537353516,134,2.25616319131902,0.499612563761732 +-149.60722,57.9053137,13.719616,259489.558185891,886731.757309993,156.436492919922,134,2.19433807113462,0.275046080605819 +-149.5447,57.9031064,13.719616,263193.754561711,886731.77036232,189.131988525391,134,2.27676498873482,0.574444172314352 +-149.48219,57.900868,13.719616,266897.827129521,886731.780577731,302.719635009766,230,2.48104059109148,1.3164314661355 +-149.41969,57.8985984,13.719616,270601.78313221,886731.776263156,441.077362060547,330,2.64451476853678,1.9102163387925 +-149.3572,57.8962977,13.719616,274305.628292088,886731.768029954,513.405944824219,430,2.71046089314222,2.14975148625736 +-135.87314,56.6332596,13.719616,1096593.54149768,886731.70714457,517.689392089844,351,2.7140692659978,2.162858126401 +-135.81492,56.6242955,13.719616,1100297.69738531,886731.753695673,250.349334716797,250,2.39854644163384,1.01678916913087 +-135.75673,56.6153032,13.719616,1104001.77680313,886731.768048782,214.853332519531,250,2.33214209427135,0.775589625822575 +-135.69857,56.6062829,13.719616,1107705.77832245,886731.770480313,192.116027832031,150,2.28356359863909,0.599138664003113 +-135.64044,56.5972345,13.719616,1111409.70956866,886731.749056851,168.719802856445,150,2.22716605927287,0.39428670356464 +-135.58234,56.5881581,13.719616,1115113.57209021,886731.713324113,149.11540222168,150,2.17352250431424,0.199438000559936 +-135.52426,56.5790536,13.719616,1118817.96337618,886731.819840903,138.934906005859,150,2.14281137159245,0.0878864006843816 +-135.46622,56.5699212,13.719616,1122521.70215861,886731.75250985,121.50634765625,150,2.08459896665921,-0.123557669507703 +-135.4082,56.5607607,13.719616,1126225.97884448,886731.82621016,117.438255310059,150,2.06980959064043,-0.177276904516081 +-135.35022,56.5515723,13.719616,1129929.61211682,886731.722620203,104.960815429688,150,2.02102719603347,-0.354468485610229 +-135.29226,56.5423559,13.719616,1133633.78930734,886731.76959464,98.4979782104492,50,1.99342731617216,-0.454719127056523 +-135.23433,56.5331117,13.719616,1137337.91887869,886731.817836268,88.9176635742188,50,1.94898804253173,-0.616135253150087 +-135.17643,56.5238395,13.719616,1141042.01154811,886731.84477883,113.857383728027,150,2.05636120015412,-0.226125297315168 +-135.11856,56.5145394,13.719616,1144746.06871478,886731.860008472,88.954963684082,50,1.94917018671406,-0.615473653490738 +-135.06073,56.5052114,13.28792547,1148449.50501644,886731.689474114,52.4163627624512,50,1.71946688141406,-1.44982162219111 +-155.00014,57.9450295,13.719616,-59054.159472466,883027.774619752,25.5025100708008,121,1.40658292773786,-2.5863054479146 +-154.93742,57.9455132,13.719616,-55350.2925801598,883027.778758191,35.8867073059082,121,1.55493361256908,-2.04745341710649 +-154.87469,57.9459656,13.719616,-51645.9340043482,883027.777706414,38.9154396057129,121,1.59012194079165,-1.91963936525331 +-154.81197,57.9463866,13.719616,-47942.258109618,883027.776176509,50.1244316101074,121,1.70004946094009,-1.52035123563614 +-154.74924,57.9467763,13.719616,-44238.0773087422,883027.770129015,60.2404518127441,121,1.77988822048092,-1.23035407273311 +-154.68651,57.9471348,13.719616,-40533.9752992223,883027.778313347,223.528274536133,121,2.34933246571565,0.838029961528796 +-154.62378,57.9474619,13.719616,-36829.9457208966,883027.778207649,232.316375732422,232,2.36607982383195,0.898861146379098 +-154.56105,57.9477576,13.719616,-33125.9819401547,883027.769645833,245.217102050781,232,2.3895507556803,0.984114270123216 +-154.49832,57.9480221,13.719616,-29422.0771554678,883027.774818629,263.33935546875,232,2.42051576828069,1.09658803418235 +-154.43559,57.9482552,13.719616,-25718.2249425426,883027.771251204,284.468231201172,232,2.45403377236761,1.2183349920169 +-154.37286,57.9484571,13.719616,-22014.4185415856,883027.781166378,249.766204833984,232,2.39753367484265,1.01311051107287 +-154.31012,57.9486276,13.719616,-18310.0610713945,883027.779363606,222.049758911133,232,2.34645030597796,0.827561134711206 +-154.24739,57.9487667,13.719616,-14606.3267258297,883027.771828275,213.296447753906,232,2.32898362275499,0.76411715575765 +-154.18465,57.9488746,13.719616,-10902.0279793334,883027.775874713,205.647811889648,232,2.31312409293925,0.70651081670639 +-154.12192,57.9489511,13.719616,-7198.33912984687,883027.772947825,200.571472167969,232,2.30226916217849,0.667082609877611 +-154.05918,57.9489963,13.719616,-3494.07270378739,883027.771454007,199.020111083984,232,2.29889696430664,0.654833824685955 +-153.99645,57.9490102,13.719616,209.59707370939,883027.772980395,197.185363769531,121,2.29487467597016,0.640223725372462 +-153.93371,57.9489928,13.719616,3913.85763470225,883027.777025381,198.790176391602,121,2.2983949190737,0.653010253101947 +-153.87098,57.948944,13.719616,7617.53477577853,883027.771806113,202.337051391602,121,2.30607541683675,0.680908013209639 +-153.80824,57.948864,13.719616,11321.8158961099,883027.781425223,202.8525390625,121,2.30718044804691,0.684921801972256 +-153.74551,57.9487525,13.719616,15025.5268672642,883027.769559255,148.544815063477,121,2.17185749741454,0.193390220259936 +-153.68277,57.9486098,13.719616,18729.8550243574,883027.773744186,54.0425033569336,35,1.73273545820569,-1.40162636405505 +-153.62004,57.9484358,13.719616,22433.6261742506,883027.777798826,44.6652069091797,35,1.64996935017542,-1.70225649222015 +-153.5573,57.9482304,13.46601579,26138.0278230318,883027.776839132,30.2027568817139,35,1.4800465867939,-2.31946446960716 +-153.36911,57.9474264,11.59799276,37249.7677417033,883027.778269641,42.6510887145996,35,1.6299301214756,-1.77504469062321 +-153.30638,57.9470957,13.71771292,40953.805244495,883027.772843639,139.145843505859,35,2.14347023783909,0.0902795909513302 +-153.05548,57.94546,9.165004476,55769.5709275668,883027.77642692,21.1145057678223,35,1.32458092024733,-2.88416014482337 +-152.86732,57.9439043,9.913937893,66881.5313543713,883027.765918997,20.7888813018799,35,1.31783111956271,-2.90867734749481 +-152.67917,57.9420669,13.719616,77993.9749007387,883027.774378175,130.715286254883,30,2.11632637830703,-0.00831465449793673 +-152.61646,57.9413919,13.6951116,81697.9983405276,883027.783934256,84.3022994995117,30,1.92583942096316,-0.700217653961527 +-152.55376,57.9406855,13.719616,85401.5772685569,883027.773021516,47.9819641113281,30,1.68107802156539,-1.58926091843297 +-152.36565,57.9383785,12.85447067,96513.8445100233,883027.773135929,29.1254940032959,30,1.46427330025162,-2.37675754847292 +-152.30295,57.937547,13.719616,100218.071831652,883027.787459409,16.1572093963623,30,1.20836635344254,-3.30628462239818 +-152.24026,57.9366841,13.719616,103921.887669595,883027.779358371,182.165924072266,30,2.2604671411801,0.515245738126796 +-152.17757,57.9357899,13.719616,107625.888756193,883027.774969873,181.850708007812,130,2.25971499625291,0.512513733067695 +-152.11488,57.9348645,13.719616,111330.08136655,883027.785912788,146.072998046875,130,2.16456994294977,0.166919742368744 +-152.0522,57.9339077,13.719616,115033.882301268,883027.773001555,198.792282104492,130,2.2983995193747,0.653026962708202 +-151.98952,57.9329197,13.719616,118737.887920522,883027.775258522,214.31428527832,130,2.33105112022884,0.771626896705176 +-151.92685,57.9319004,13.719616,122441.514716711,883027.763580723,138.387054443359,130,2.14109546550533,0.0816537400076237 +-151.86417,57.9308499,13.719616,126145.949747989,883027.785965059,65.1405410766602,31,1.81385136162265,-1.10699025006074 +-151.8015,57.929768,13.719616,129850.019481465,883027.783181606,60.3660583496094,31,1.78079281917133,-1.22706831209137 +-151.73884,57.9286549,13.719616,133553.72977512,883027.776433914,72.4997100830078,31,1.86033626988683,-0.938143795131461 +-151.67618,57.9275105,13.719616,137257.67798837,883027.774115129,82.7441101074219,31,1.91773708959116,-0.729647634140261 +-151.61352,57.9263348,13.719616,140961.87070614,883027.776804277,71.5673828125,31,1.85471513554743,-0.958561359483639 +-151.55087,57.9251279,13.719616,144665.723686185,883027.774475737,71.9303970336914,31,1.85691245747951,-0.950580059048221 +-151.48822,57.9238897,13.719616,148369.834316444,883027.777244225,68.9078369140625,31,1.8382686171904,-1.01829980846009 +-151.42558,57.9226203,13.719616,152073.618331478,883027.773999328,64.0417785644531,31,1.80646338461519,-1.13382549129044 +-151.36294,57.9213196,13.719616,155777.673138093,883027.776003487,69.0105514526367,31,1.83891549779986,-1.01595015344841 +-151.3003,57.9199876,13.719616,159482.005315818,883027.783914509,71.4234771728516,31,1.85384098951711,-0.961736507371871 +-151.23767,57.9186244,13.719616,163186.03056422,883027.784994658,74.6662902832031,31,1.87312457439566,-0.891693023009885 +-151.17505,57.91723,13.719616,166889.755428897,883027.7782586,74.4546966552734,31,1.87189209855742,-0.896169727038024 +-151.11243,57.9158043,13.719616,170593.777354063,883027.777264377,79.5703887939453,31,1.9007514801002,-0.79134421598706 +-151.04982,57.9143474,13.719616,174297.512004064,883027.767646772,78.8293075561523,31,1.89668771169719,-0.806104982741769 +-150.98721,57.9128592,13.719616,178001.55684165,883027.764111575,82.2187805175781,31,1.9149710309652,-0.73969474858148 +-150.9246,57.9113398,13.719616,181705.917921848,883027.778569302,83.4037246704102,31,1.92118544593373,-0.717122219645145 +-150.862,57.9097892,13.719616,185410.011369616,883027.783867714,86.3919067382812,31,1.9364730593361,-0.66159324424845 +-150.79941,57.9082074,13.719616,189113.843722853,883027.779115477,93.8889236450195,31,1.97261436027905,-0.53031772346935 +-150.73682,57.9065943,13.719616,192818.012481021,883027.781313993,103.25505065918,31,2.0139113041034,-0.380315436178022 +-150.67424,57.9049501,13.719616,196521.932678167,883027.783999022,117.939117431641,31,2.07165787351808,-0.170563413552032 +-150.61167,57.9032746,13.719616,200225.61195578,883027.764012878,117.629608154297,130,2.07051665030806,-0.174708661988343 +-150.5491,57.901568,13.719616,203929.646131554,883027.77354611,129.553039550781,130,2.11244760678264,-0.0224034597861509 +-150.48653,57.8998301,13.719616,207634.042886078,883027.791147656,135.890762329102,130,2.13318993498228,0.0529385966848323 +-150.42398,57.898061,13.719616,211337.627350325,883027.765203574,142.045684814453,130,2.15242804488939,0.122816902970707 +-150.36143,57.8962608,13.719616,215041.586268865,883027.769172988,157.605926513672,130,2.19757254439587,0.28679461070126 +-150.29888,57.8944293,13.719616,218745.927380715,883027.781655047,171.06706237793,130,2.23316639759168,0.416081645005621 +-150.23634,57.8925667,13.719616,222450.065562205,883027.792382613,179.321685791016,130,2.25363281298594,0.490421507414106 +-150.17381,57.8906729,13.719616,226154.00794795,883027.789466845,199.781478881836,130,2.30055522366847,0.660857096002439 +-150.11129,57.8887479,13.719616,229857.761059205,883027.772187952,227.809509277344,230,2.35757184854239,0.867957751709492 +-150.04877,57.8867918,13.719616,233561.921165648,883027.786161255,249.353515625,230,2.39681549569765,1.01050187942949 +-149.98626,57.8848045,13.719616,237265.90501408,883027.785492707,264.993103027344,230,2.42323457070607,1.10646350061481 +-149.92376,57.882786,13.719616,240969.719120652,883027.769509096,260.308441162109,230,2.4154882514388,1.07832665801644 +-149.86126,57.8807364,13.719616,244673.959718386,883027.785543565,258.677154541016,230,2.41275807504479,1.06840987808346 +-149.79877,57.8786557,13.719616,248378.042874136,883027.797225054,259.918243408203,230,2.41483676327728,1.07596026706058 +-149.73629,57.8765438,13.719616,252081.975783903,883027.792777704,246.918655395508,230,2.39255390333516,0.995022559589358 +-149.67382,57.8744007,13.719616,255785.764956663,883027.771590313,245.000823974609,230,2.38916754496463,0.982722339424688 +-149.61135,57.8722266,13.719616,259490.005838588,883027.79443179,205.513687133789,230,2.31284075102343,0.705481637994295 +-149.5489,57.8700213,13.719616,263193.525539622,883027.760838804,256.441589355469,230,2.40898845985953,1.05471755977531 +-149.48645,57.8677849,13.719616,266897.510633086,883027.760095033,459.848968505859,330,2.66261521664947,1.97596233272001 +-149.424,57.8655174,13.719616,270601.967588916,883027.793322061,573.5732421875,330,2.75858888282471,2.32456608188009 +-135.83125,56.5923295,13.719616,1100297.92555338,883027.814202077,533.294128417969,450,2.72696680211582,2.20970565890494 +-135.77311,56.5833448,13.719616,1104001.82115631,883027.783542097,246.676818847656,250,2.3921283391145,0.993476788871803 +-135.715,56.574332,13.719616,1107705.63806375,883027.726597671,205.704727172852,150,2.31324427206174,0.706947341581803 +-135.65691,56.5652912,13.719616,1111409.96825604,883027.820254702,185.11181640625,150,2.26743414234143,0.540551874924828 +-135.59886,56.5562224,13.719616,1115113.63547897,883027.729165549,161.874267578125,150,2.20917781640603,0.328948271116597 +-135.54083,56.5471256,13.719616,1118817.8251297,883027.787404103,149.762969970703,150,2.17540444403491,0.206273742784477 +-135.48283,56.5380008,13.719616,1122521.95135674,883027.826436094,128.26806640625,150,2.10811854795895,-0.0381278370701884 +-135.42486,56.528848,13.719616,1126226.0187171,883027.845089349,126.916053771973,150,2.10351656002702,-0.0548435707771138 +-135.36692,56.5196672,13.719616,1129930.03176194,883027.842200581,114.38459777832,150,2.05836754936769,-0.218837664302418 +-135.30901,56.5104586,13.719616,1133633.98884032,883027.838047149,103.517990112305,150,2.01501583121866,-0.376303478431954 +-135.25113,56.501222,13.719616,1137337.90065083,883027.810040549,109.007705688477,150,2.03745719903878,-0.29479002510519 +-135.19328,56.4919575,13.719616,1141041.76861039,883027.767754283,132.222579956055,150,2.12130562695705,0.00977139781797775 +-135.13546,56.4826652,13.719616,1144745.59409292,883027.720759334,107.731880187988,150,2.03234423942564,-0.313361753804108 +-135.07766,56.473345,13.719616,1148449.97511429,883027.830145492,74.7458953857422,50,1.87358734869858,-0.890012094652746 +-135.0199,56.463997,12.46891269,1152153.7321896,883027.76019219,43.776725769043,50,1.64124327587939,-1.7339520847329 +-134.90446,56.4452176,1.970247712,1159561.75397174,883027.769522463,49.2308158874512,50,1.69223703326375,-1.54872820284546 +-155.06186,57.9113602,10.39864816,-62758.3042025786,879323.774421744,11.8798112869263,20,1.07480954184909,-3.79140108301487 +-154.9992,57.9118747,13.719616,-59054.3814075636,879323.773153439,33.9681739807129,121,1.53107220122931,-2.1341248738174 +-154.93653,57.912358,13.719616,-55349.9726545032,879323.774252008,40.8404579162598,121,1.61109060289063,-1.84347519945779 +-154.87387,57.9128099,13.719616,-51646.2536162581,879323.772361103,48.125301361084,121,1.68237346208115,-1.58455550872418 +-154.8112,57.9132306,13.719616,-47942.0354470698,879323.773479522,206.96662902832,121,2.3159003261468,0.716594888132064 +-154.74854,57.91362,13.719616,-44238.4936509364,879323.78122079,254.206253051758,121,2.40518622927256,1.0409067730188 +-154.68587,57.9139781,13.719616,-40534.4396858633,879323.781507519,258.908721923828,232,2.41314668086974,1.06982140535884 +-154.6232,57.9143049,13.719616,-36830.4579256068,879323.781377452,266.333801269531,232,2.42542628763036,1.11442444206213 +-154.56052,57.9146004,13.719616,-33125.9507995618,879323.775677118,276.226135253906,232,2.44126476714477,1.1719543204106 +-154.49785,57.9148646,13.719616,-29422.0936529378,879323.774790772,256.692413330078,232,2.40941303307513,1.05625973087964 +-154.43518,57.9150975,13.719616,-25718.2889146062,879323.773038882,236.173629760742,232,2.37323140433279,0.924837728022433 +-154.3725,57.9152992,13.719616,-22013.9389505617,879323.778158995,224.025985717773,232,2.35029839690241,0.841538499303321 +-154.30983,57.9154695,13.719616,-18310.2192412062,879323.774895909,216.147064208984,232,2.33474934115814,0.785059890697762 +-154.24715,57.9156086,13.719616,-14605.9411280339,879323.779432119,208.333236694336,232,2.31875856116941,0.726976813555659 +-154.18448,57.9157163,13.719616,-10902.2800489767,879323.774312933,201.896636962891,232,2.30512908486428,0.677470665375584 +-154.1218,57.9157928,13.719616,-7198.04738745026,879323.777983636,198.861465454102,232,2.29855063550255,0.653575859617392 +-154.05913,57.9158379,13.719616,-3494.41853902765,879323.770790166,197.736953735352,232,2.2960878392865,0.644630280808703 +-153.99645,57.9158518,13.719616,209.795070842164,879323.773440525,194.923126220703,232,2.28986336807717,0.622021224735428 +-153.93377,57.9158344,13.719616,3914.00904972818,879323.77584113,200.137542724609,121,2.30132856324287,0.663666086069758 +-153.8711,57.9157857,13.719616,7617.63902568184,879323.776853718,208.150146484375,121,2.31837672085495,0.725589860545487 +-153.80842,57.9157057,13.719616,11321.8735428177,879323.778239332,171.541717529297,121,2.23436975405551,0.420452579154367 +-153.74575,57.9155944,13.6968901,15025.5372570735,879323.777186631,52.1707954406738,35,1.71742745839885,-1.45722938869162 +-153.68307,57.9154518,13.719616,18729.8187124183,879323.777719289,137.977203369141,35,2.13980733807645,0.0769748935177489 +-153.6204,57.9152779,13.719616,22433.5425645928,879323.774826685,217.276473999023,35,2.33701270485007,0.793281073655173 +-153.55772,57.9150727,13.12805335,26137.8973573167,879323.774795131,31.4601516723633,35,1.49776081206704,-2.25512134727183 +-153.30703,57.9139391,9.067687818,40954.0750509144,879323.781231481,24.2189655303955,35,1.38415558909458,-2.66776794326673 +-153.24437,57.9135774,13.68781021,44657.5467091237,879323.768156455,137.880233764648,35,2.13950201104727,0.0758658585987753 +-153.1817,57.9131845,9.570631868,48361.6887637011,879323.772203877,61.0559692382812,35,1.78572812987823,-1.20914185492598 +-152.74307,57.9095581,13.49240836,74289.9179989272,879323.779628316,129.341491699219,35,2.11173786537098,-0.0249814431736534 +-152.68042,57.9089149,13.719616,77993.7516735643,879323.774785092,96.5401992797852,30,1.98470819096104,-0.48638947850941 +-152.55512,57.9075347,9.088175754,85401.8420301727,879323.776350155,12.7730464935303,30,1.10629449299824,-3.67703875374137 +-152.49248,57.9067977,5.564182397,89105.5209057227,879323.770038978,54.3988990783691,30,1.73559011056165,-1.39125745189929 +-152.30456,57.9043991,13.11387696,100217.535189754,879323.774225598,41.6833305358887,30,1.61996241220056,-1.81125025577763 +-152.24192,57.903537,13.719616,103921.887870433,879323.780952957,180.22998046875,130,2.2558270356394,0.498391550384985 +-152.17929,57.9026436,13.719616,107625.834564235,879323.772992493,86.8250579833984,130,1.93864508201288,-0.653703837929399 +-152.11666,57.901719,13.719616,111329.972515246,879323.777052405,128.556304931641,130,2.10909338109458,-0.0345869648765208 +-152.05404,57.9007632,13.719616,115033.717307832,879323.776277835,162.781677246094,130,2.21160551898841,0.337766379831084 +-151.99142,57.8997761,13.719616,118737.666807377,879323.776191972,140.459030151367,130,2.14754966535206,0.105097236062997 +-151.9288,57.8987577,13.719616,122441.827600182,879323.777293892,108.136497497559,130,2.03397229882462,-0.307448177372602 +-151.86619,57.8977081,13.719616,126145.614940779,879323.772268293,69.8272323608398,31,1.84402482889144,-0.997391604575521 +-151.80358,57.8966272,13.719616,129849.626723479,879323.768359795,62.6706848144531,31,1.79706444034403,-1.16796513960905 +-151.74097,57.8955151,13.719616,133553.869151944,879323.777278556,62.858585357666,31,1.79836460292603,-1.16324257800788 +-151.67837,57.8943718,13.719616,137257.757805153,879323.778917683,66.5453338623047,31,1.82311760828704,-1.07333259732556 +-151.61577,57.8931972,13.719616,140961.890606092,879323.782243236,69.1968383789062,31,1.84008625188505,-1.01169764044453 +-151.55318,57.8919914,13.719616,144665.682751836,879323.777228057,70.5388946533203,31,1.84842864997671,-0.98139566941812 +-151.49059,57.8907543,13.719616,148369.732184341,879323.773985872,60.4000015258789,31,1.78103694959267,-1.22618156071931 +-151.428,57.889486,13.719616,152074.045049541,879323.784303586,60.2939605712891,31,1.7802738126058,-1.2289534920766 +-151.36542,57.8881865,13.719616,155778.036921177,879323.785364003,68.1710739135742,31,1.83360013558663,-1.03525706616229 +-151.30285,57.8868558,13.719616,159481.71434389,879323.776149081,71.3000030517578,31,1.85308954844039,-0.964465955845183 +-151.24028,57.8854938,13.719616,163185.675297238,879323.769067943,73.8711395263672,31,1.86847479844154,-0.908582336453449 +-151.17771,57.8841007,13.719616,166889.92540595,879323.787128572,69.8860015869141,31,1.84439019373733,-0.996064495169736 +-151.11515,57.8826763,13.719616,170593.881177682,879323.783024889,70.2906036376953,31,1.84689727294238,-0.986958067905325 +-151.0526,57.8812207,13.719616,174297.548688238,879323.766962012,72.3678207397461,31,1.85954549462477,-0.941016116593018 +-150.99005,57.8797339,13.719616,178001.525448235,879323.764803161,75.1489105224609,31,1.87592268874843,-0.881529473019267 +-150.9275,57.8782159,13.719616,181705.817994957,879323.777297354,77.2603988647461,31,1.88795694590447,-0.837817616109588 +-150.86496,57.8766667,13.719616,185409.841892347,879323.777290767,79.3862762451172,31,1.89974543106486,-0.794998473238402 +-150.80243,57.8750863,13.719616,189113.603675026,879323.763890432,82.3311462402344,31,1.91556416183862,-0.737540327952795 +-150.7399,57.8734748,13.719616,192817.700300155,879323.776409629,84.9783401489258,31,1.92930824391986,-0.687617898882161 +-150.67738,57.871832,13.719616,196521.548413279,879323.76375436,87.6063537597656,31,1.94253560505779,-0.639572347764446 +-150.61486,57.8701581,13.719616,200225.744410115,879323.777540598,92.7790069580078,31,1.9674497198214,-0.549077171746696 +-150.55235,57.868453,13.719616,203929.704395712,879323.776747181,94.2462692260742,31,1.97426416750809,-0.524325152711608 +-150.48984,57.8667167,13.719616,207634.025869582,879323.791824064,100.75365447998,31,2.00326080758442,-0.419001079489309 +-150.42735,57.8649492,13.719616,211337.533413635,879323.759999632,117.690055847168,130,2.07073976893392,-0.173898231454817 +-150.36485,57.8631506,13.719616,215042.005857286,879323.787111338,144.595733642578,130,2.16015547910775,0.150885149681107 +-150.30237,57.8613208,13.719616,218745.677397437,879323.765768384,156.280975341797,130,2.19390611297147,0.273477085264146 +-150.23989,57.8594599,13.719616,222449.735867335,879323.771688603,172.17399597168,130,2.23596755908741,0.426256263089205 +-150.17742,57.8575678,13.719616,226153.597425725,879323.760601052,192.134857177734,130,2.28360616187713,0.599293265832439 +-150.11495,57.8556446,13.719616,229857.858909591,879323.777546139,207.941772460938,230,2.31794174150546,0.724009891392662 +-150.05249,57.8536903,13.719616,233561.93583179,879323.788319862,240.250839233398,230,2.38066491340113,0.951838354693399 +-149.99004,57.8517048,13.719616,237265.83534956,879323.781080002,260.819732666016,230,2.41634044543326,1.0814220698447 +-149.9276,57.8496882,13.719616,240969.563291308,879323.766300171,262.753051757812,230,2.41954776886348,1.09307198400452 +-149.86516,57.8476404,13.719616,244673.717803802,879323.769012723,264.335296630859,330,2.42215515824529,1.10254276646227 +-149.80273,57.8455616,13.719616,248377.713013454,879323.775141549,267.976837158203,330,2.42809725697985,1.12412616511002 +-149.74031,57.8434516,13.719616,252081.556796902,879323.761760037,280.642211914062,330,2.44815299464164,1.1969743287751 +-149.67789,57.8413105,13.719616,255785.845905515,879323.777916433,274.160797119141,230,2.4380053541295,1.16011520201005 +-149.61548,57.8391383,13.719616,259489.995839749,879323.785610618,268.495391845703,330,2.42893683635529,1.12717575704143 +-149.55308,57.8369351,13.719616,263194.012322839,879323.795402584,386.035125732422,330,2.58662682337049,1.69995079908398 +-149.49069,57.8347007,13.719616,266897.903307766,879323.784432911,568.335266113281,330,2.75460460554886,2.31009404958825 +-135.78946,56.551383,13.719616,1104001.94562203,879323.82060009,361.5595703125,351,2.55817986159359,1.596623314339 +-135.7314,56.5423778,13.719616,1107705.57007961,879323.715549345,242.154235839844,250,2.38409207026788,0.964286766641381 +-135.67336,56.5333445,13.719616,1111409.70759058,879323.746730971,208.326034545898,150,2.31874354720697,0.72692227855866 +-135.61535,56.5242833,13.719616,1115113.76568752,879323.768169954,179.62141418457,150,2.25435811132796,0.49305599801307 +-135.55737,56.5151941,13.719616,1118817.75196878,879323.767933408,155.652389526367,150,2.19215579222155,0.267119420709157 +-135.49942,56.5060769,13.719616,1122521.67099685,879323.744833204,135.792526245117,150,2.13287586788392,0.0517978153399185 +-135.4415,56.4969317,13.719616,1126225.52732846,879323.697690102,127.549644470215,150,2.10567925240219,-0.0469880547766314 +-135.3836,56.4877586,13.719616,1129929.91340052,879323.806194694,127.056503295898,150,2.10399689900654,-0.0530988425010768 +-135.32574,56.4785576,13.719616,1133633.65178611,879323.729451252,115.576713562012,150,2.06287034108922,-0.202482239545113 +-135.2679,56.4693288,13.719616,1137337.92583605,879323.817853558,115.574333190918,150,2.06286139644419,-0.202514729048924 +-135.2101,56.460072,13.719616,1141041.5643118,879323.706862875,128.254684448242,150,2.10807323649628,-0.0382924212357976 +-135.15232,56.4507874,13.719616,1144745.74743863,879323.759832069,122.046417236328,150,2.08652503490166,-0.116561639896504 +-135.09457,56.441475,13.719616,1148449.88871059,879323.804360626,109.696189880371,150,2.04019154332068,-0.284858106213771 +-135.03685,56.4321348,13.719616,1152153.99258795,879323.83931397,43.2137145996094,50,1.63562159935393,-1.75437161845959 +-134.97916,56.4227667,10.86601782,1155858.06667619,879323.852866933,38.3846969604492,50,1.58415811628781,-1.94130167809623 +-155.06086,57.878205,10.70564056,-62758.3651454224,875619.776550651,19.8454570770264,20,1.29766110595139,-2.98194059402619 +-154.99826,57.8787191,13.719616,-59054.4983031341,875619.783965769,112.474411010742,121,2.05105372759485,-0.245403552553956 +-154.93565,57.8792019,13.719616,-55350.1449643692,875619.779273881,189.763793945312,121,2.27821335461546,0.579705050597626 +-154.87305,57.8796534,13.719616,-51646.4815952623,875619.77945768,250.119918823242,232,2.39814827905779,1.01534292900776 +-154.81044,57.8800737,13.719616,-47942.3184061567,875619.779346918,271.248657226562,232,2.43336759695599,1.14326954420815 +-154.74783,57.8804627,13.719616,-44238.2404899921,875619.775894625,273.310607910156,232,2.4366564881414,1.15521573573657 +-154.68522,57.8808205,13.719616,-40534.2411369646,875619.780073666,268.820648193359,232,2.42946262395037,1.12908556766148 +-154.62261,57.881147,13.719616,-36830.3138884973,875619.780533842,255.932601928711,232,2.40812561193599,1.05158344983571 +-154.56,57.8814422,13.719616,-33126.4521494003,875619.777110089,243.024673461914,232,2.38565036826656,0.96994694975511 +-154.49738,57.8817062,13.719616,-29422.0577107863,875619.776392627,232.42121887207,232,2.36627577439982,0.899572894771471 +-154.43477,57.8819389,13.719616,-25718.3071411982,875619.77649672,225.844818115234,232,2.35381013036442,0.854294117585837 +-154.37215,57.8821404,13.719616,-22014.0107225776,875619.780171786,215.920883178711,232,2.33429464794183,0.783408315153749 +-154.30954,57.8823105,13.719616,-18310.3450540537,875619.772163484,207.267227172852,232,2.31653063743788,0.718884358650026 +-154.24692,57.8824495,13.719616,-14606.1203236149,875619.779823923,206.872756958008,232,2.31570330225676,0.715879241127199 +-154.1843,57.8825571,13.719616,-10901.9216207982,875619.772887605,200.624984741211,232,2.30238501671813,0.667503426633746 +-154.12169,57.8826335,13.719616,-7198.33380630295,875619.774724142,195.316955566406,232,2.29073994625403,0.62520520687413 +-154.05907,57.8826786,13.719616,-3494.16726551159,875619.771399342,195.942031860352,232,2.29212760724029,0.6302455876541 +-153.99645,57.8826925,13.719616,209.993067878638,875619.775702168,201.600509643555,232,2.30449162566587,0.675155231617993 +-153.93384,57.8826751,13.719616,3913.56224033064,875619.775866124,206.099319458008,121,2.3140765577369,0.709970440711982 +-153.87122,57.8826264,13.62155176,7617.7299080723,875619.772520927,187.054336547852,121,2.27196778105586,0.557019344764955 +-153.8086,57.8825465,12.817286,11321.9111058032,875619.776829723,76.2918701171875,35,1.88247826074175,-0.857717764392991 +-153.55814,57.8819141,13.719616,26137.7200304695,875619.774417112,216.652008056641,35,2.33576271868254,0.788740767113122 +-153.49552,57.8816779,12.80563597,29842.067690038,875619.783291682,143.77033996582,35,2.15766929969227,0.141854636417848 +-153.24508,57.8804202,7.726223125,44657.6888059799,875619.774125397,113.219367980957,35,2.0539207262141,-0.234989795245936 +-152.80685,57.8770159,12.92956646,70585.968959539,875619.782005252,42.3323974609375,35,1.62667286508566,-1.78687597554499 +-152.74426,57.8764045,13.71885736,74289.6131425091,875619.769587311,68.4170227050781,35,1.83516417112222,-1.02957604267683 +-152.43131,57.8728791,10.34134359,92809.9447360231,875619.781288375,67.6298294067383,30,1.83013829193805,-1.04783147040248 +-152.36873,57.8720803,13.26290496,96513.8877358282,875619.781877838,109.815353393555,30,2.04066306350164,-0.28314541033127 +-152.30615,57.8712502,13.719616,100218.002305447,875619.779816561,143.542175292969,30,2.15697952341068,0.13934917208135 +-152.24358,57.8703889,13.719616,103921.703206672,875619.771041754,44.1375160217285,30,1.64480788821821,-1.72100439527664 +-152.18101,57.8694964,13.719616,107625.588523908,875619.770520467,74.8858108520508,30,1.8743995366257,-0.887061996279923 +-152.11844,57.8685726,13.719616,111329.665127448,875619.767537129,86.7436370849609,30,1.93823762778292,-0.655183827991614 +-152.05587,57.8676177,13.719616,115033.93894802,875619.784888804,85.2444610595703,30,1.93066616937228,-0.682685526048455 +-151.99331,57.8666314,13.719616,118737.825988936,875619.771681957,106.47053527832,130,2.02722943747889,-0.331940174384525 +-151.93075,57.865614,13.719616,122441.923350509,875619.778673124,104.418365478516,130,2.01877689066346,-0.362642237015204 +-151.8682,57.8645654,13.719616,126145.646380419,875619.776215143,67.8476791381836,31,1.83153499636246,-1.04275824127389 +-151.80565,57.8634855,13.719616,129849.593527039,875619.771551808,62.357837677002,31,1.79489104716421,-1.17585952398634 +-151.7431,57.8623744,13.719616,133553.770991049,875619.776391841,60.0747146606445,31,1.77869171669438,-1.23470011600199 +-151.68056,57.8612321,13.719616,137257.593790367,875619.770627192,63.4597015380859,31,1.80249802520739,-1.14822880848579 +-151.61802,57.8600586,13.719616,140961.660001467,875619.774385796,65.7227554321289,31,1.81771576297792,-1.09295364132842 +-151.55548,57.8588538,13.719616,144665.976581091,875619.777096445,58.0067749023438,31,1.76347871995731,-1.28995806237262 +-151.49295,57.8576179,13.719616,148369.9577325,875619.779349983,54.0801086425781,31,1.73303755539706,-1.40052906082887 +-151.43043,57.8563508,13.719616,152073.610399807,875619.768932921,57.8140411376953,31,1.76203332714129,-1.29520814163659 +-151.36791,57.8550525,13.719616,155777.532655249,875619.768266774,61.5166664123535,31,1.78899279301662,-1.19728366657973 +-151.30539,57.853723,13.719616,159481.731040164,875619.778005299,66.4459762573242,31,1.82246868667603,-1.07568966583741 +-151.24288,57.8523623,13.719616,163185.620564965,875619.774245843,70.4637298583984,31,1.84796562797449,-0.983077497489831 +-151.18037,57.8509704,13.719616,166889.799298424,875619.781130042,71.3536911010742,31,1.85341644393092,-0.96327857811831 +-151.11787,57.8495473,13.719616,170593.682248567,875619.773671,69.5054321289062,31,1.84201874777599,-1.00467826377938 +-151.05537,57.848093,13.719616,174297.867481716,875619.777157076,76.2376708984375,31,1.88216961990457,-0.858838836008513 +-150.99288,57.8466076,13.719616,178001.769497796,875619.776675481,77.2870635986328,31,1.88810680727027,-0.837273276854288 +-150.93039,57.845091,13.719616,181705.986845181,875619.787501939,77.5914916992188,31,1.88981410127538,-0.831071897717515 +-150.86791,57.8435432,13.719616,185409.934526789,875619.782480988,80.3815612792969,31,1.9051564373922,-0.775344153802526 +-150.80544,57.8419643,13.719616,189113.618536873,875619.771874921,84.1749420166016,31,1.92518282589911,-0.70260259464506 +-150.74297,57.8403542,13.719616,192817.637451273,875619.772680858,91.3513107299805,31,1.9607147830921,-0.573540384289819 +-150.6805,57.8387129,13.719616,196521.997798565,875619.785708586,85.0734558105469,31,1.92979407485224,-0.685853222265782 +-150.61805,57.8370405,13.719616,200225.522477788,875619.76263978,89.355339050293,31,1.95112050704655,-0.608389533366281 +-150.55559,57.8353369,13.719616,203929.993151534,875619.781934182,88.9679336547852,31,1.94923350387898,-0.615243667475235 +-150.49315,57.8336022,13.719616,207633.641165163,875619.763480769,91.4820327758789,31,1.96133580627947,-0.571284650815631 +-150.43071,57.8318364,13.719616,211337.656069467,875619.768448728,100.94376373291,31,2.00407949356154,-0.416027378344179 +-150.36827,57.8300394,13.719616,215042.044964682,875619.786570879,109.001434326172,130,2.03743221276487,-0.294880782383825 +-150.30585,57.8282113,13.719616,218745.630689892,875619.764026248,121.847290039062,130,2.08581587464369,-0.119137512367957 +-150.24343,57.8263521,13.719616,222449.602791222,875619.765376942,151.055236816406,130,2.17913578608758,0.219827042150825 +-150.18101,57.8244618,13.719616,226153.967753648,875619.791555135,187.696151733398,130,2.27345536852927,0.562422687068135 +-150.11861,57.8225403,13.719616,229857.549653419,875619.763135176,205.289596557617,230,2.31236694122592,0.703760625570961 +-150.05621,57.8205877,13.719616,233561.537400269,875619.759223728,198.60368347168,230,2.29798729902638,0.651529660743721 +-149.99381,57.818604,13.719616,237265.937474194,875619.780799307,243.678161621094,230,2.38681660956047,0.974183071013017 +-149.93143,57.8165893,13.719616,240969.572610078,875619.767435278,263.36279296875,330,2.42055441926002,1.09672842557137 +-149.86905,57.8145434,13.719616,244673.633701241,875619.768181388,263.879028320312,330,2.42140487621218,1.09981752796619 +-149.80668,57.8124664,13.719616,248377.535019296,875619.7578116,267.271392822266,330,2.42695247688485,1.11996799705221 +-149.74431,57.8103584,13.719616,252081.873851726,875619.784797196,294.990875244141,330,2.46980858244458,1.27563360479551 +-149.68195,57.8082192,13.719616,255786.066559978,875619.789384417,312.380859375,330,2.49468441533815,1.36598973013457 +-149.61961,57.806049,13.719616,259489.526642603,875619.754190062,364.499298095703,330,2.56169669634821,1.60939746197239 +-149.55726,57.8038478,13.719616,263194.035124956,875619.795844912,492.908203125,330,2.69276604587288,2.08547875036288 +-149.49493,57.8016154,13.719616,266897.825366108,875619.774267955,596.829162597656,430,2.77585003572099,2.38726351602293 +-135.74777,56.5104201,13.61800352,1107705.5849245,875619.717284721,383.914367675781,450,2.58423436553118,1.69126070933615 +-135.68978,56.5013944,13.719616,1111409.52191865,875619.697261325,226.864501953125,250,2.35576654607467,0.861400377862099 +-135.63181,56.4923407,13.719616,1115113.97024989,875619.821031263,195.917724609375,150,2.29207372824502,0.630049883764679 +-135.57388,56.4832591,13.719616,1118817.74837133,875619.762854223,173.027816772461,150,2.23811592798232,0.434059752121033 +-135.51597,56.4741495,13.719616,1122522.04694137,875619.847181216,156.787399291992,150,2.19531115632129,0.27858060374998 +-135.4581,56.465012,13.719616,1126225.68438298,875619.746053259,137.579833984375,150,2.13855478105694,0.0724252489075148 +-135.40025,56.4558466,13.719616,1129929.84827839,875619.796895106,130.042617797852,150,2.11408570339344,-0.0164534253363965 +-135.34243,56.4466532,13.719616,1133633.9547073,875619.818786937,124.718872070312,150,2.09593217453603,-0.0823922236795285 +-135.28464,56.437432,13.719616,1137338.00200509,875619.831996743,130.227783203125,150,2.11470364786202,-0.0142088746475998 +-135.22688,56.428183,13.719616,1141041.99464924,875619.835356826,131.514572143555,150,2.11897387640684,0.00130181427175259 +-135.16915,56.4189061,13.719616,1144745.94023181,875619.817000056,123.568008422852,150,2.09190604709741,-0.097016267707755 +-135.11145,56.4096014,13.719616,1148449.84011689,875619.786489964,120.157516479492,150,2.07975094337515,-0.141167073839021 +-135.05378,56.4002689,13.719616,1152153.69876458,875619.742684949,118.683898925781,150,2.07439180503728,-0.160632993932553 +-134.99614,56.3909087,13.719616,1155857.51748101,875619.695151666,102.293609619141,50,2.00984850376269,-0.395072686654143 +-134.82338,56.3626615,2.419391576,1166969.97398404,875619.827569693,89.7182540893555,50,1.95288081365439,-0.60199559732507 +-155.1224,57.8445041,13.26732005,-66462.2298111749,871915.780047536,19.9334163665771,20,1.29958173833921,-2.97496430899057 +-155.05986,57.8450489,13.719616,-62758.3145080442,871915.780721446,49.4818229675293,121,1.69444569116231,-1.54070572694416 +-154.99731,57.8455625,13.719616,-59053.9183923801,871915.776848071,240.180938720703,232,2.38053853788414,0.951379322744508 +-154.93477,57.8460448,13.719616,-55350.2192383865,871915.775342024,236.105178833008,232,2.37310551318602,0.924380455444457 +-154.87222,57.8464959,13.719616,-51646.0261343432,871915.769901978,278.952270507812,232,2.44552990066304,1.18744650273927 +-154.80967,57.8469158,13.719616,-47941.9246088837,871915.769192765,281.975646972656,232,2.4502116017871,1.20445177751238 +-154.74713,57.8473045,13.719616,-44238.5001902616,871915.77966407,265.960083007812,232,2.42481645982541,1.11220937341236 +-154.68457,57.8476619,13.719616,-40533.9701714882,871915.769966903,249.136322021484,232,2.39643704870694,1.00912725193968 +-154.62202,57.8479881,13.719616,-36830.1041189654,871915.771073965,237.74641418457,232,2.37611397540294,0.93530804891693 +-154.55947,57.8482831,13.719616,-33126.303384948,871915.776159553,230.92138671875,232,2.36346415684016,0.889360297279229 +-154.49691,57.8485468,13.719616,-29421.969404995,871915.769475141,224.26432800293,232,2.35076019920254,0.843215897068887 +-154.43436,57.8487793,13.719616,-25718.2796887381,871915.77147552,216.596481323242,232,2.33565139709857,0.788336415345803 +-154.3718,57.8489806,13.719616,-22014.0435001912,871915.773740588,211.810317993164,232,2.32594711223204,0.753087682831905 +-154.30925,57.8491506,13.719616,-18310.43850521,871915.772186589,206.588577270508,232,2.31510630476573,0.713710775839755 +-154.24669,57.8492894,13.719616,-14606.2738943941,871915.771825472,205.117431640625,232,2.31200256989368,0.702437124890325 +-154.18413,57.849397,13.719616,-10902.135193782,871915.77590212,203.121688842773,232,2.3077562987954,0.687013456254946 +-154.12157,57.8494733,13.719616,-7198.0158622431,871915.773192466,203.19873046875,232,2.30792099026474,0.687611662679212 +-154.05902,57.8495184,13.719616,-3494.50138413779,871915.775353955,217.466766357422,232,2.33739289673718,0.794662039106708 +-153.99646,57.8495323,13.719616,209.598977259137,871915.780753824,199.762908935547,121,2.30051485355964,0.66071046024441 +-153.9339,57.8495149,13.719616,3913.69970729731,871915.779299121,163.236862182617,121,2.21281823796431,0.342171321296008 +-153.87134,57.8494662,9.692774246,7617.80739927533,871915.77099864,31.0760250091553,35,1.49242546228483,-2.27450086054126 +-153.62111,57.8489594,6.706633053,22433.8469262506,871915.778386028,17.104793548584,35,1.23311783670571,-3.21638017040963 +-153.55856,57.8487546,13.52919287,26137.4958357489,871915.776725491,136.919128417969,35,2.13646412589915,0.0648313926420324 +-153.496,57.8485185,12.75192975,29841.7832687486,871915.771980884,84.0849914550781,35,1.92471848438382,-0.704289215564846 +-153.43345,57.8482513,12.32200355,33545.5314521774,871915.778181065,129.925003051758,35,2.11369273569587,-0.0178807961781194 +-153.37089,57.8479528,9.732019969,37249.9313018356,871915.782666523,34.9576034545898,35,1.54354165159042,-2.08883227097036 +-152.87052,57.8444404,10.393831,66881.5483915091,871915.773716778,17.5889739990234,35,1.24524050690725,-3.17234717208311 +-152.74544,57.84325,9.975510881,74289.7675990574,871915.772462179,12.2408123016357,35,1.08781023859488,-3.74417884166584 +-152.37027,57.8389297,11.25850725,96513.6520616822,871915.770454832,29.1982765197754,30,1.46535721720042,-2.37282045273417 +-152.30775,57.8381004,13.50074968,100217.699951322,871915.771152092,25.5011100769043,30,1.40655908591556,-2.58639204821832 +-152.24523,57.8372399,13.719616,103921.925442998,871915.777464444,38.8779754638672,30,1.58970364134263,-1.92115874824671 +-152.18272,57.8363482,13.719616,107625.743000505,871915.773619234,66.1294479370117,30,1.82039489713449,-1.08322226137075 +-152.12021,57.8354253,13.719616,111329.751261879,871915.775156049,69.4638366699219,30,1.84175876686071,-1.0056225886696 +-152.0577,57.8344712,13.719616,115033.956776851,871915.78253958,103.97469329834,130,2.01692764796907,-0.36935921430765 +-151.9952,57.8334859,13.719616,118737.774006829,871915.778370975,60.6709861755371,30,1.78298105423386,-1.21912001775978 +-151.9327,57.8324694,13.719616,122441.801587369,871915.779910047,124.374176025391,130,2.09473021657741,-0.0867580780581854 +-151.8702,57.8314217,13.719616,126146.046065646,871915.787668502,62.2304344177246,31,1.79400283271454,-1.17908577238919 +-151.80771,57.8303428,13.719616,129849.921900426,871915.782621276,60.3782348632812,31,1.78088041242437,-1.22675014839471 +-151.74522,57.8292327,13.719616,133554.027724546,871915.783748367,47.1969413757324,31,1.67391385484844,-1.61528321680569 +-151.68274,57.8280914,13.719616,137257.777994869,871915.770940522,53.9714088439941,31,1.73216375482984,-1.40370295389652 +-151.62026,57.826919,13.719616,140961.770942127,871915.775486973,57.461238861084,31,1.75937498512152,-1.30486399861876 +-151.55778,57.8257154,13.719616,144666.013487842,871915.786814442,50.2936592102051,31,1.70151323468609,-1.51503439158804 +-151.49531,57.8244806,13.719616,148369.920085838,871915.783187345,53.7649307250977,31,1.73049909056114,-1.4097494896629 +-151.43285,57.8232146,13.719616,152073.497276365,871915.763553693,53.5115432739258,31,1.72844747621599,-1.41720153855354 +-151.37038,57.8219175,13.719616,155777.935331435,871915.784951103,57.1932945251465,31,1.75734511408263,-1.31223706961486 +-151.30792,57.8205892,13.719616,159482.057035235,871915.790514874,58.5132026672363,31,1.76725386947702,-1.27624564178206 +-151.24547,57.8192297,13.719616,163185.86892464,871915.779239776,64.3659057617188,31,1.80865588505497,-1.12586170389122 +-151.18302,57.8178391,13.719616,166889.969149221,871915.786425581,66.2092742919922,31,1.8209188276833,-1.0813191960728 +-151.12058,57.8164173,13.719616,170593.772608619,871915.77592349,73.541374206543,31,1.86653174090873,-0.915640076016453 +-151.05814,57.8149644,13.719616,174297.877428978,871915.78417898,73.7772064208984,31,1.86792220661106,-0.91058950770715 +-150.99571,57.8134803,13.719616,178001.698528441,871915.773959834,77.2345581054688,31,1.88781166609098,-0.838345313859176 +-150.93328,57.8119651,13.719616,181705.834009626,871915.782857142,78.8457870483398,31,1.89677849271198,-0.805775240184571 +-150.87086,57.8104187,13.719616,185409.698809052,871915.772555307,81.374397277832,31,1.91048778486496,-0.755979178063383 +-150.80844,57.8088412,13.719616,189113.891005716,871915.781790974,85.7578277587891,31,1.93327377183191,-0.673213969631227 +-150.74603,57.8072326,13.719616,192817.825007348,871915.782321181,87.7353363037109,31,1.94317454514307,-0.637251535003053 +-150.68363,57.8055928,13.719616,196521.507865335,871915.762123746,87.8685455322266,31,1.94383343768434,-0.634858249226512 +-150.62123,57.8039219,13.719616,200225.537623041,871915.761653505,90.1544494628906,31,1.9549871656618,-0.594344725621439 +-150.55883,57.8022199,13.719616,203929.920771451,871915.781747998,93.5757751464844,31,1.97116343333331,-0.535587904272059 +-150.49644,57.8004868,13.719616,207634.071712574,871915.791995296,93.3221282958984,31,1.96998463471478,-0.53986963731719 +-150.43406,57.7987226,13.719616,211337.996934435,871915.791590606,96.6013031005859,130,1.98498298485832,-0.48539134864052 +-150.37169,57.7969272,13.719616,215041.703533445,871915.768591977,109.722785949707,130,2.04029682615838,-0.284475688896558 +-150.30932,57.7951008,13.719616,218745.788872683,871915.777469679,117.40421295166,130,2.06968368148426,-0.177734242509376 +-150.24696,57.7932432,13.719616,222449.66857833,871915.763337873,122.361305236816,130,2.08764410098773,-0.112496872458661 +-150.1846,57.7913546,13.719616,226153.939968388,871915.781810796,168.166488647461,130,2.22573945611412,0.389104873698979 +-150.12225,57.7894349,13.719616,229858.018055877,871915.78807066,202.213928222656,130,2.30581106590343,0.679947815166551 +-150.05991,57.7874841,13.719616,233561.909319275,871915.781405331,203.139999389648,230,2.3077954468111,0.687155653021911 +-149.99758,57.7855022,13.719616,237265.620235368,871915.761118089,200.577758789062,230,2.30228277429409,0.667132052966731 +-149.93525,57.7834893,13.719616,240969.748683547,871915.77396051,251.386505126953,330,2.40034196027833,1.0233110053397 +-149.87293,57.7814453,13.719616,244673.709711917,871915.772947924,259.258636474609,330,2.41373323260512,1.07195192868026 +-149.81062,57.7793702,13.719616,248377.509792059,871915.757429751,284.634002685547,330,2.45428678013553,1.2192539884456 +-149.74831,57.7772641,13.719616,252081.746766697,871915.775874839,382.678100585938,330,2.58283360968513,1.68617276428779 +-149.68601,57.7751269,13.719616,255785.835709954,871915.779673394,413.462677001953,330,2.61643631218682,1.80822737094007 +-149.62372,57.7729587,13.719616,259489.782352482,871915.779365765,444.697479248047,330,2.64806466767298,1.92311058569726 +-149.56144,57.7707594,13.719616,263193.593873111,871915.763216485,493.809631347656,430,2.6935595562325,2.08836100647946 +-149.49916,57.7685291,13.719616,266897.868065341,871915.781983864,580.546630859375,430,2.7638371090213,2.343629137419 +-135.70616,56.4694409,13.719616,1111410.00781963,871915.84061823,412.418334960938,351,2.61533796455366,1.80423785883684 +-135.64825,56.4603947,13.719616,1115113.65851712,871915.731989776,215.768127441406,250,2.33398729253121,0.782291912574413 +-135.59036,56.4513207,13.719616,1118817.81576481,871915.784316912,195.196273803711,150,2.29047152295192,0.624230216825213 +-135.5325,56.4422187,13.719616,1122521.89810485,871915.807576995,175.735549926758,150,2.2448596247583,0.458554783654087 +-135.47467,56.4330888,13.719616,1126225.90702223,871915.811299405,160.630584716797,150,2.20582824025218,0.316781654461577 +-135.41687,56.423931,13.719616,1129929.8470394,871915.794291456,144.700759887695,150,2.16047081179745,0.152030528015018 +-135.3591,56.4147453,13.719616,1133633.72267302,871915.755369292,147.323776245117,150,2.16827284228577,0.180369729669794 +-135.30136,56.4055318,13.719616,1137337.53533499,871915.704072065,145.567840576172,150,2.16306543951698,0.161454956472843 +-135.24364,56.3962904,13.719616,1141041.88469836,871915.800328717,121.791885375977,150,2.08561835353631,-0.119854965408103 +-135.18596,56.3870212,13.719616,1144745.58796989,871915.710617963,127.973899841309,150,2.10712140472041,-0.0417497459256027 +-135.1283,56.3777243,13.719616,1148449.83066348,871915.788676009,120.317085266113,150,2.08032730240169,-0.139073573345389 +-135.07067,56.3683995,13.719616,1152154.0313959,871915.840124942,115.905799865723,150,2.06410516837651,-0.197996994382859 +-135.01308,56.3590471,13.719616,1155857.5931256,871915.72188735,123.908012390137,150,2.09309939051096,-0.0926817038156224 +-134.95551,56.3496668,13.71692858,1159561.71388408,871915.74825743,129.873718261719,150,2.11352127448547,-0.018503592234207 +-155.30878,57.8095274,10.35157507,-77574.2672410615,868211.779044107,18.4948329925537,20,1.26705041401098,-3.0931273643151 +-155.2463,57.8101653,12.83649387,-73870.0489363493,868211.775934304,26.955774307251,20,1.43065181149526,-2.49888039216431 +-155.18382,57.810772,13.719616,-70165.9614055522,868211.774722192,51.7936325073242,20,1.71427637100175,-1.46867503752777 +-155.12134,57.8113475,13.719616,-66461.9980954775,868211.775102402,38.6783866882324,121,1.58746835095878,-1.92927796093624 +-155.05886,57.8118918,13.719616,-62758.1524524196,868211.776785321,242.617370605469,232,2.3849218916997,0.967300914936365 +-154.99638,57.8124049,13.719616,-59054.4179221733,868211.779496995,238.733963012695,232,2.37791420744315,0.941847005524338 +-154.93389,57.8128868,13.719616,-55350.1953048336,868211.77464465,304.497589111328,232,2.48358385841457,1.32566933897373 +-154.8714,57.8133375,13.719616,-51646.0706905399,868211.771435701,281.950927734375,232,2.45017352793397,1.20431348241047 +-154.80891,57.813757,13.719616,-47942.0375237793,868211.769643258,263.916259765625,232,2.42146614773788,1.10004008363617 +-154.74642,57.8141453,13.719616,-44238.0892486561,868211.769056152,247.223922729492,232,2.393090493143,0.996971606929403 +-154.68393,57.8145025,13.719616,-40534.219193893,868211.780647819,234.540390014648,232,2.37021764300003,0.913890886648751 +-154.62144,57.8148284,13.719616,-36830.4210434737,868211.781900766,227.797302246094,232,2.35754857651844,0.867873221076028 +-154.55894,57.8151231,13.719616,-33126.0954697379,868211.778831641,222.841217041016,232,2.34799552168093,0.833173799192877 +-154.49645,57.8153866,13.719616,-29422.4212060241,868211.781825954,219.406509399414,232,2.34124950817174,0.808670352623512 +-154.43395,57.8156189,13.719616,-25718.2064044445,868211.781332636,212.889465332031,232,2.32815417124873,0.761104351137868 +-154.37145,57.8158199,13.719616,-22014.0372151031,868211.771053473,208.592498779297,232,2.31929868665363,0.72893870348151 +-154.30896,57.8159898,13.719616,-18310.4995899779,868211.775982941,203.901321411133,232,2.30942004029361,0.693056640255526 +-154.24646,57.8161285,13.719616,-14606.4017535975,868211.778794276,198.946823120117,232,2.29873700851172,0.654252819582858 +-154.18396,57.8162359,13.719616,-10902.3298240386,868211.771563009,207.159301757812,232,2.31630443853412,0.718062739667947 +-154.12146,57.8163122,13.719616,-7198.27717069949,868211.776573958,226.06575012207,232,2.3542347699539,0.855836529779033 +-154.05896,57.8163572,13.719616,-3494.23728665085,868211.771449753,164.759979248047,121,2.21685172858385,0.356822110499036 +-153.99646,57.8163711,13.719616,209.796416797816,868211.77850673,114.458305358887,121,2.05864731156422,-0.217821488152528 +-153.93396,57.8163537,10.84149635,3913.83048869755,868211.775398875,31.1325721740723,35,1.49321500358834,-2.27163302116941 +-153.55897,57.8155941,7.991699639,26137.8174858654,868211.775504593,15.4679956436157,35,1.18943404108697,-3.37505218469355 +-153.49647,57.8153583,11.47591626,29842.0378372164,868211.779996805,107.037406921387,35,2.02953557937205,-0.323563608790132 +-153.30899,57.8144636,9.601990967,40953.8570041994,868211.779612288,86.5665130615234,35,1.93734992429056,-0.658408220451687 +-152.87158,57.8112838,11.64312052,66881.7114381995,868211.768967745,55.6494789123535,35,1.74546110206607,-1.35540319329374 +-152.30934,57.8049497,12.52066684,100217.811718911,868211.779435059,31.1496047973633,30,1.49345254103008,-2.27077021738105 +-152.24688,57.80409,13.6220756,103921.963580683,868211.785594912,48.8213882446289,30,1.68861012449555,-1.56190217071441 +-152.18443,57.8031991,13.719616,107625.706688141,868211.778271437,31.0078353881836,30,1.49147144983038,-2.27796610607808 +-152.12198,57.802277,13.719616,111329.640233718,868211.773003305,79.5909881591797,30,1.90086389670369,-0.79093588679629 +-152.05953,57.8013237,13.719616,115033.770763817,868211.770254234,96.3717346191406,30,1.98394967603008,-0.489144621240392 +-151.99709,57.8003393,13.719616,118737.511841952,868211.763788734,92.6188430786133,30,1.96669935182833,-0.551802722473858 +-151.93464,57.7993238,13.719616,122442.055271842,868211.789301543,129.274307250977,130,2.11151221917368,-0.025801054568092 +-151.87221,57.798277,13.719616,126145.630345721,868211.76966417,60.6171913146973,31,1.78259580955078,-1.22051933640851 +-151.80977,57.7971991,13.719616,129850.020837154,868211.783041378,56.5398902893066,31,1.752354961444,-1.33036272832973 +-151.74734,57.79609,13.719616,133554.048344963,868211.780263952,47.6083297729492,31,1.67768294553426,-1.60159280362921 +-151.68492,57.7949498,13.719616,137257.719020918,868211.771378726,49.5138092041016,31,1.69472633882765,-1.53968633451884 +-151.6225,57.7937784,13.719616,140961.632418626,868211.765347995,50.7078552246094,31,1.70507524170907,-1.50209616538256 +-151.56008,57.7925759,13.719616,144665.794666869,868211.773922238,48.6084442138672,31,1.68671172105098,-1.56879771388336 +-151.49767,57.7913422,13.719616,148369.620047693,868211.764202104,51.9688453674316,31,1.71574306786916,-1.46334757586836 +-151.43526,57.7900774,13.719616,152073.707312046,868211.769194105,55.9881858825684,31,1.74809639580443,-1.3458310542483 +-151.37285,57.7887815,13.719616,155778.062964308,868211.789532503,58.8769836425781,31,1.76994555233251,-1.26646868136817 +-151.31046,57.7874544,13.719616,159481.508669469,868211.766678272,63.2489929199219,31,1.80105361486283,-1.153475319133 +-151.24806,57.7860962,13.719616,163185.828434142,868211.782827526,66.8740768432617,31,1.82525779989441,-1.06555881053608 +-151.18567,57.7847068,13.719616,166889.843941968,868211.778915524,74.7980117797852,31,1.87389005395344,-0.888912582766401 +-151.12329,57.7832863,13.719616,170593.561240474,868211.765125536,68.1935882568359,31,1.83374354304976,-1.03473616932364 +-151.06091,57.7818347,13.719616,174297.579473428,868211.766741568,72.5772171020508,31,1.86080031161331,-0.936458263130193 +-150.99853,57.780352,13.719616,178001.905138099,868211.784491032,78.6059722900391,31,1.89545554392838,-0.810580567773781 +-150.93616,57.7788381,13.719616,181705.952600329,868211.780598811,79.7283782958984,31,1.90161293047608,-0.788215182339427 +-150.8738,57.7772932,13.719616,185409.727335079,868211.776465155,81.0702362060547,31,1.90886143837853,-0.761886532707606 +-150.81144,57.7757171,13.719616,189113.829521617,868211.777352958,82.321907043457,31,1.91551542260055,-0.737717362777045 +-150.74909,57.7741099,13.719616,192817.672491585,868211.766174932,91.0434265136719,31,1.95924859448131,-0.578865999816099 +-150.68674,57.7724717,13.719616,196521.854823828,868211.782809654,90.3934936523438,31,1.95613717192918,-0.590167574613868 +-150.6244,57.7708023,13.719616,200225.79146581,868211.775617054,94.0097579956055,31,1.97317293470288,-0.528288821728984 +-150.56206,57.7691018,13.719616,203930.081003996,868211.785622657,95.5607681274414,31,1.9802796319963,-0.50247526870591 +-150.49974,57.7673703,13.719616,207633.544045765,868211.76230135,100.177108764648,130,2.00076849325808,-0.428053876499909 +-150.43741,57.7656077,13.719616,211337.965579112,868211.787486745,99.6058959960938,130,1.99828504648376,-0.437074464030516 +-150.3751,57.763814,13.719616,215041.574151562,868211.766592895,105.034950256348,130,2.02133383409703,-0.353354688640161 +-150.31279,57.7619892,13.719616,218745.561535322,868211.763047206,120.584350585938,130,2.081290948806,-0.135573334552857 +-150.25048,57.7601334,13.719616,222449.933580278,868211.78891379,129.932052612305,130,2.11371629930655,-0.0177952064184039 +-150.18819,57.7582464,13.719616,226153.512724534,868211.754710752,153.166229248047,130,2.18516302072762,0.241719678707496 +-150.12589,57.7563285,13.719616,229858.081458591,868211.795321189,197.820999145508,130,2.2962723910476,0.645300625481312 +-150.06361,57.7543795,13.719616,233561.869582497,868211.785567695,205.333969116211,130,2.31246080216831,0.70410155530429 +-150.00133,57.7523994,13.719616,237266.06886032,868211.794532042,197.43017578125,230,2.29541353219237,0.642181004976393 +-149.93907,57.7503883,13.719616,240969.499790913,868211.761782866,201.010955810547,330,2.3032197286563,0.670535338643687 +-149.8768,57.7483461,13.719616,244673.947441781,868211.784356603,253.993667602539,330,2.40482288922011,1.03958701824071 +-149.81455,57.7462729,13.719616,248377.639642138,868211.763893501,300.519317626953,330,2.47787239403972,1.30492367015005 +-149.7523,57.7441687,13.719616,252081.768117728,868211.773996556,496.433502197266,330,2.69586108251332,2.09672080685237 +-149.69006,57.7420335,13.719616,255785.746656749,868211.77719937,564.055541992188,430,2.75132187063772,2.29817021940514 +-149.62783,57.7398672,13.719616,259489.582425585,868211.76174852,507.562744140625,430,2.70548973673246,2.13169482726783 +-135.66465,56.4284453,13.719616,1115114.01859857,868211.838285403,302.658966064453,250,2.48095354411554,1.31611528667321 +-135.60681,56.4193788,13.719616,1118817.96168926,868211.823013103,210.008529663086,250,2.32223693430716,0.739611257618533 +-135.549,56.4102844,13.719616,1122521.82300688,868211.785743281,190.323486328125,150,2.27949238446847,0.584350852095194 +-135.49122,56.4011621,13.719616,1126225.60707935,868211.725267432,182.425003051758,150,2.26108436218995,0.517487661006955 +-135.43346,56.3920119,13.719616,1129929.91107409,868211.810527726,168.708862304688,150,2.22713789674995,0.394184409242992 +-135.37574,56.3828339,13.719616,1133633.5511301,868211.711324777,156.532684326172,150,2.19460503287586,0.276015761848476 +-135.31804,56.373628,13.719616,1137337.72011686,868211.756594986,155.056045532227,150,2.19048870375684,0.26106407957091 +-135.26037,56.3643943,13.719616,1141041.82678853,868211.785735019,152.656387329102,150,2.18371498042471,0.236459983015492 +-135.20273,56.3551328,13.719616,1144745.87561639,868211.797571885,135.57145690918,150,2.13216826319122,0.0492275931255364 +-135.14512,56.3458436,13.719616,1148449.86794198,868211.801647391,130.094116210938,150,2.11425765509421,-0.0158288476793155 +-135.08754,56.3365266,13.719616,1152153.81133051,868211.786094129,124.163482666016,150,2.09399388562659,-0.0894326422413522 +-135.02999,56.3271818,13.719616,1155857.71023592,868211.749765049,131.478378295898,150,2.11885433869004,0.00086761916486987 +-134.97247,56.3178094,13.719616,1159561.56280297,868211.712916878,139.371353149414,150,2.14417351660528,0.0928341001658925 +-134.91497,56.3084092,12.99927062,1163265.97238571,868211.828174616,110.205131530762,150,2.04220181723452,-0.277556217569399 +-134.85751,56.2989814,11.12768448,1166969.75178989,868211.766035432,78.4010162353516,50,1.89432169205364,-0.814699041416387 +-155.5572,57.7735107,11.59749233,-92390.5011531995,864507.788052204,14.5421209335327,20,1.16262775195326,-3.47242027810385 +-155.24513,57.7770088,13.67300033,-73870.1389061467,864507.773923419,21.0464725494385,20,1.3231793172412,-2.88925116699895 +-155.18271,57.777615,13.719616,-70166.1280645561,864507.779901402,40.2230186462402,121,1.60447466029878,-1.86750619132941 +-155.12029,57.7781899,13.719616,-66462.241463395,864507.772981593,264.848541259766,232,2.42299758525886,1.10560270182816 +-155.05787,57.7787337,13.719616,-62758.472165001,864507.775209932,271.845855712891,232,2.43432271657355,1.14673881127742 +-154.99544,57.7792464,13.719616,-59054.2204470418,864507.777421309,314.845672607422,232,2.4980977285238,1.3783878578814 +-154.93301,57.7797279,13.719616,-55350.0731495943,864507.778198135,292.208251953125,232,2.46569247623587,1.26068273219179 +-154.87058,57.7801782,13.719616,-51646.023720915,864507.777298317,264.623352050781,232,2.42262816645503,1.10426086729004 +-154.80815,57.7805973,13.719616,-47942.065608853,864507.77449545,246.122604370117,232,2.39115150196932,0.989928637543439 +-154.74572,57.7809853,13.719616,-44238.1921354518,864507.780747289,235.316787719727,232,2.37165291125578,0.919104190619981 +-154.68329,57.781342,13.719616,-40534.3970091527,864507.773521926,229.576721191406,232,2.3609278490105,0.880147703307575 +-154.62085,57.7816676,13.719616,-36830.0802334253,864507.769431241,221.578659057617,232,2.34552792979363,0.824210801137336 +-154.55842,57.7819621,13.719616,-33126.4216922204,864507.779961161,216.842849731445,232,2.33614510610952,0.790129707392151 +-154.49598,57.7822253,13.719616,-29422.22862411,864507.772092247,212.664535522461,232,2.32769507189113,0.75943677123105 +-154.43354,57.7824574,13.719616,-25718.0875007132,864507.773575619,208.620697021484,232,2.31935739208827,0.729151938376348 +-154.3711,57.7826583,13.719616,-22013.9918616983,864507.773125749,204.908096313477,232,2.31155911855151,0.700826383041962 +-154.30866,57.782828,13.719616,-18309.9351526188,864507.770641597,202.360061645508,232,2.30612480303688,0.681087397984758 +-154.24623,57.7829666,13.719616,-14606.5039804439,864507.779406316,203.76350402832,232,2.30912640038449,0.691990056292443 +-154.18379,57.7830739,13.719616,-10902.5054777908,864507.772055548,204.371688842773,232,2.31042073377703,0.696691444613667 +-154.12134,57.7831501,13.719616,-7197.93301748985,864507.772546818,65.1731033325195,121,1.81406840118741,-1.10620190041228 +-154.0589,57.7831951,13.719616,-3493.96649198882,864507.772398175,76.8157348632812,35,1.88545018961951,-0.846922870436027 +-153.99646,57.783209,13.719616,209.993856077705,864507.781114571,51.2000007629395,35,1.70926996744732,-1.48685972420729 +-153.49695,57.7821971,13.01689342,29841.646824534,864507.777029188,161.532821655273,35,2.20826077939481,0.325617330943401 +-153.43451,57.7819303,8.234170137,33545.8462558545,864507.777187784,21.4694538116455,35,1.33182099601493,-2.85786212311207 +-153.18478,57.7805514,5.496947186,48361.5227758598,864507.774375346,34.9532089233398,35,1.54348705286356,-2.08903058913036 +-152.87264,57.7781264,10.93724148,66881.7559870735,864507.779359831,45.5688095092773,35,1.65866768273419,-1.67066166561541 +-152.43574,57.7734224,9.181383319,92809.5342132885,864507.772532945,17.1000003814697,30,1.23299612008047,-3.21682227993391 +-152.37333,57.7726257,10.06825046,96513.8518702421,864507.772530212,29.8044261932373,30,1.47428076503449,-2.34040757996669 +-152.31093,57.771798,8.414486483,100217.746336905,864507.779428783,30.9661273956299,30,1.49088689615854,-2.28008937186245 +-152.18613,57.7700489,13.71959143,107626.073372364,864507.779373203,65.7126922607422,30,1.81764926067753,-1.09319519666509 +-152.12374,57.7691277,13.719616,111329.925216611,864507.778863848,111.873779296875,30,2.04872830957515,-0.253850134541857 +-152.06135,57.7681753,13.719616,115033.973755579,864507.777540154,95.1841430664062,30,1.97856460434715,-0.508704738645252 +-151.99897,57.7671918,13.719616,118737.631992037,864507.769165284,101.741310119629,130,2.00749732572763,-0.403612836370489 +-151.93659,57.7661772,13.719616,122441.4996389,864507.770995999,108.241851806641,130,2.03439521358334,-0.30591203025702 +-151.87421,57.7651314,13.719616,126145.583562676,864507.772377575,57.3751564025879,31,1.75872388241788,-1.30722898948157 +-151.81183,57.7640544,13.719616,129849.89030298,864507.77383521,50.7211570739746,31,1.70518915230882,-1.50168240957094 +-151.74946,57.7629464,13.719616,133553.832438658,864507.778124702,49.4000015258789,31,1.69372696233824,-1.54331635517883 +-151.68709,57.7618072,13.719616,137258.010425332,864507.782470507,52.898567199707,31,1.7234439089787,-1.43537592291963 +-151.62473,57.7606369,13.719616,140961.837197376,864507.777380697,49.9190139770508,31,1.69826599837799,-1.52682928071257 +-151.56237,57.7594355,13.719616,144665.912462056,864507.783551849,53.2649879455566,31,1.72644183307177,-1.4244866069209 +-151.50002,57.7582029,13.719616,148369.649939984,864507.768083649,56.4885482788086,31,1.75196041377679,-1.33179583807215 +-151.43767,57.7569393,13.719616,152073.648506126,864507.775141647,57.0227470397949,31,1.75604813537764,-1.31694806646597 +-151.37532,57.7556445,13.719616,155777.915512747,864507.783037114,64.800178527832,31,1.81157620237593,-1.11525427783995 +-151.31298,57.7543186,13.719616,159481.863836502,864507.779565195,68.2595291137695,31,1.83416328798603,-1.03321153590796 +-151.25065,57.7529616,13.719616,163185.499976232,864507.763716666,67.6884536743164,31,1.83051459286248,-1.04646463803798 +-151.18831,57.7515735,13.719616,166890.016835579,864507.784757381,71.0980453491211,31,1.85185766112696,-0.968940522183202 +-151.12599,57.7501543,13.719616,170593.641302063,864507.767992846,70.397834777832,31,1.84755930177705,-0.98455339021598 +-151.06367,57.748704,13.719616,174297.566276906,864507.763277688,74.128173828125,31,1.86998330126652,-0.903103023623531 +-151.00135,57.7472226,13.719616,178001.798254109,864507.7713378,76.691780090332,31,1.88474881828126,-0.849470451327881 +-150.93904,57.7457102,13.719616,181705.750008813,864507.7767108,79.7332458496094,31,1.90163944408685,-0.788118877337373 +-150.87673,57.7441666,13.719616,185410.022254155,864507.7840844,82.0185012817383,31,1.91391182919168,-0.743542071749191 +-150.81443,57.742592,13.719616,189114.027237578,864507.788068077,85.7800674438477,31,1.93338638336353,-0.672804932405873 +-150.75214,57.7409863,13.719616,192817.771962416,864507.77661941,87.7908325195312,31,1.94344916745451,-0.636254028382885 +-150.68985,57.7393495,13.719616,196521.856119004,864507.778460106,92.8256759643555,31,1.96766812047854,-0.548283878222187 +-150.62757,57.7376817,13.719616,200225.692423379,864507.775413703,97.7400360107422,31,1.99007249470099,-0.466904796201195 +-150.56529,57.7359827,13.719616,203929.881686403,864507.77503897,98.1396789550781,31,1.99184463293707,-0.46046788430914 +-150.50302,57.7342528,13.719616,207633.835455998,864507.780381876,102.508529663086,130,2.01076000423555,-0.391761856768593 +-150.44076,57.7324918,13.719616,211337.561347551,864507.768325336,107.657173156738,130,2.03204297200068,-0.314456043081828 +-150.3785,57.7306997,13.719616,215041.659044081,864507.770456793,108.953605651855,130,2.03724160712742,-0.295573116463328 +-150.31625,57.7288766,13.719616,218745.541201893,864507.76588529,120.972396850586,130,2.08268628549784,-0.13050507341937 +-150.254,57.7270224,13.719616,222449.808099177,864507.776191845,132.626739501953,130,2.12263109305375,0.0145858690068991 +-150.19176,57.7251372,13.719616,226153.872368172,864507.779399536,142.618728637695,130,2.15417656064853,0.129168011284012 +-150.12953,57.723221,13.719616,229857.740451226,864507.77477508,189.010726928711,130,2.27648645239413,0.573432448822791 +-150.0673,57.7212737,13.719616,233562.012653023,864507.7856206,186.279708862305,134,2.27016555049972,0.550473128977272 +-150.00509,57.7192955,13.719616,237265.507695095,864507.76375161,183.702972412109,231,2.2641161834791,0.528500101297105 +-149.94287,57.7172862,13.719616,240970.012956155,864507.793363909,207.426620483398,330,2.31686449162464,0.720097012347808 +-149.88067,57.7152459,13.719616,244673.75460188,864507.777753903,242.296401977539,330,2.38434696505413,0.965212617259247 +-149.81847,57.7131746,13.719616,248377.925472099,864507.789391739,400.009460449219,330,2.60207026275873,1.75604577893851 +-149.75628,57.7110722,13.719616,252081.939509109,864507.780205585,642.557067871094,430,2.80791170501639,2.50372065021529 +-149.6941,57.7089389,13.719616,255785.80172725,864507.771861306,630.244812011719,430,2.79950927937989,2.47320064201249 +-135.68103,56.3964924,13.719616,1115113.8732932,864507.794779766,460.359344482422,450,2.66309696298867,1.97771217292811 +-135.62324,56.3874335,13.719616,1118817.59437869,864507.722618932,247.838195800781,250,2.39416823887294,1.0008862870398 +-135.56547,56.3783466,13.719616,1122521.82612967,864507.783097917,202.241958618164,150,2.30587126256027,0.680166466606041 +-135.50773,56.3692319,13.719616,1126225.97376752,864507.828545323,192.364349365234,150,2.28412458792749,0.601176337220855 +-135.45002,56.3600893,13.719616,1129930.04486112,864507.847025694,182.554077148438,150,2.26139153689295,0.518603407204654 +-135.39234,56.3509189,13.719616,1133634.04084248,864507.848058959,170.758666992188,150,2.23238275587543,0.413235234618573 +-135.33469,56.3417207,13.719616,1137337.96619416,864507.830447742,169.264846801758,150,2.22856677249033,0.39937449377382 +-135.27707,56.3324946,13.719616,1141041.82849565,864507.782291251,162.926498413086,150,2.21199172383392,0.339169186063845 +-135.21948,56.3232408,13.719616,1144745.62602196,864507.72383659,153.642028808594,150,2.18651003329241,0.246612412818467 +-135.16191,56.3139593,13.719616,1148449.95641362,864507.826834526,133.984146118164,150,2.12705341283693,0.0306489967151135 +-135.10438,56.30465,13.719616,1152153.64082688,864507.734106997,140.776916503906,150,2.14853144843646,0.108663352454303 +-135.04687,56.295313,13.719616,1155857.86698183,864507.801619535,144.226501464844,150,2.15904506886091,0.146851822721957 +-134.98939,56.2859483,13.719616,1159562.04609578,864507.855287669,139.366104125977,150,2.14415715983761,0.0927746877170349 +-134.93195,56.2765559,13.719616,1163265.58938025,864507.718804445,148.949172973633,150,2.17303809617822,0.197678491946058 +-134.87453,56.2671358,13.7111817,1166969.68764993,864507.740798106,104.497413635254,150,2.01910554156824,-0.361448483122732 +-134.24488,56.1616958,8.991527603,1207713.79057671,864507.774878878,46.8593597412109,50,1.67079635035658,-1.6266068829445 +-155.55573,57.7403564,13.719616,-92390.0377116093,860803.771415882,22.1393260955811,20,1.34516439714682,-2.80939508161518 +-155.24396,57.7438514,13.71753332,-73870.0982752312,860803.776707368,32.6353302001953,20,1.51368801119156,-2.19726921397636 +-155.1816,57.744457,13.719616,-70166.1710172602,860803.778812894,281.619140625,121,2.44966216888385,1.20245608038403 +-155.11924,57.7450314,13.719616,-66462.3676218027,860803.775860081,288.831909179688,232,2.46064517094449,1.24234947872914 +-155.05687,57.7455747,13.719616,-62758.087603408,860803.769277968,301.238800048828,232,2.47891090896911,1.30869585279524 +-154.9945,57.7460869,13.719616,-59053.9182067673,860803.769359717,281.422760009766,232,2.44935921799899,1.2013556762994 +-154.93214,57.746568,13.719616,-55350.4466761212,860803.784183106,261.335418701172,232,2.41719827350099,1.08453794623522 +-154.86977,57.7470178,13.719616,-51646.4792656452,860803.773944502,246.46305847168,232,2.39175183353537,0.99210921314302 +-154.80739,57.7474366,13.719616,-47942.0089877336,860803.773594873,235.845489501953,232,2.37262757486561,0.922644447047575 +-154.74502,57.7478242,13.719616,-44238.2171281773,860803.775584168,227.781875610352,232,2.35751916471428,0.867766389008347 +-154.68265,57.7481807,13.719616,-40534.5032619187,860803.783109253,222.761947631836,232,2.34784100631802,0.832612555291681 +-154.62027,57.748506,13.719616,-36830.2672141714,860803.779277227,218.246643066406,232,2.33894757238243,0.800309064798857 +-154.55789,57.7488001,13.719616,-33126.0961955001,860803.770585991,212.594863891602,232,2.32755276813422,0.758919883368431 +-154.49551,57.7490632,13.719616,-29421.9834888166,860803.779224945,207.418746948242,232,2.3168480062875,0.720037132897926 +-154.43313,57.749295,13.719616,-25717.9228249214,860803.771556539,204.196716308594,232,2.31004875390895,0.695340307559184 +-154.37076,57.7494957,13.719616,-22014.5012574754,860803.773116346,204.382202148438,232,2.3104430742158,0.696772591463887 +-154.30837,57.7496653,13.719616,-18309.930984708,860803.773859214,206.587783813477,232,2.31510463674189,0.713704717101065 +-154.24599,57.7498037,13.719616,-14605.9868103945,860803.77247586,206.552276611328,121,2.31502998611623,0.713433564721241 +-154.18361,57.749911,13.719616,-10902.0683915553,860803.776750739,168.408477783203,121,2.22636395035715,0.391373215038068 +-154.12123,57.7499871,13.719616,-7198.16922857554,860803.775461216,74.9850158691406,35,1.87497448771838,-0.884973609803942 +-154.05885,57.7500321,13.719616,-3494.28275999601,860803.779737933,228.42366027832,35,2.35874108642199,0.87220475742191 +-153.99647,57.7500459,13.719616,209.597534919267,860803.778389449,100.238723754883,35,2.00103552855931,-0.427083928066368 +-153.37267,57.7484707,7.616848122,37249.4993166365,860803.774460595,83.1829833984375,35,1.92003449249253,-0.721302811058409 +-152.8737,57.7449679,9.606480133,66881.6825899562,860803.772404842,31.8418369293213,35,1.50299811387895,-2.2360979722162 +-152.4372,57.7402682,13.4327431,92810.0578097975,860803.781289124,13.5485744476318,30,1.13189360206676,-3.58405548289136 +-152.37486,57.7394723,13.719616,96513.6957735396,860803.773531952,82.1933135986328,30,1.91483648925138,-0.740183442488099 +-152.31252,57.7386453,13.21236417,100217.503779058,860803.772150996,85.6680221557617,30,1.93281874032498,-0.674866773943321 +-152.25017,57.7377871,13.719616,103922.082391889,860803.782043865,137.929626464844,30,2.1396575600719,0.0764308570543292 +-152.18784,57.7368978,13.719616,107625.656566417,860803.767861024,38.1149711608887,30,1.58109559550388,-1.95242562771392 +-152.1255,57.7359774,13.719616,111330.014093883,860803.776992687,96.9761276245117,30,1.98666483821544,-0.479282377198712 +-152.06317,57.7350259,13.719616,115033.973961122,860803.776930001,117.301727294922,130,2.06930440724878,-0.179111874788273 +-152.00085,57.7340433,13.719616,118737.542675606,860803.766476254,105.059860229492,130,2.02143681868677,-0.352980619215513 +-151.93852,57.7330296,13.719616,122441.9142654,860803.781324107,99.3941116333008,31,1.99736065642032,-0.440432112588143 +-151.8762,57.7319847,13.719616,126145.908071923,860803.774501954,51.3913612365723,31,1.7108901212793,-1.4809748630516 +-151.81389,57.7309088,13.719616,129849.529896286,860803.767186001,51.6398506164551,31,1.71298497727093,-1.47336574815858 +-151.75157,57.7298018,13.719616,133553.974110495,860803.787298587,54.6031951904297,31,1.73721805686172,-1.3853442862753 +-151.68926,57.7286636,13.719616,137258.060084619,860803.784569335,60.1243591308594,31,1.7790504602357,-1.23339705706434 +-151.62696,57.7274944,13.719616,140961.79355407,860803.780218823,60.305347442627,31,1.78035582394541,-1.22865560348278 +-151.56466,57.726294,13.719616,144665.775568091,860803.772618948,54.900276184082,31,1.73957452923918,-1.37678490599616 +-151.50236,57.7250626,13.719616,148370.011818174,860803.784693036,57.8872375488281,31,1.76258282498698,-1.29321220861874 +-151.44007,57.7238001,13.719616,152073.915441501,860803.782996784,62.6230430603027,31,1.7967341675956,-1.16916478450056 +-151.37778,57.7225065,13.719616,155778.086696606,860803.789945236,62.906852722168,31,1.79869795764428,-1.16203173852229 +-151.3155,57.7211818,13.719616,159481.938319474,860803.782171122,67.4403839111328,31,1.82892003388851,-1.05225653136386 +-151.25322,57.719826,13.719616,163186.070566386,860803.783235927,66.6806945800781,31,1.82400011501206,-1.0701270810078 +-151.19095,57.7184392,13.719616,166889.895698746,860803.779846463,69.2527313232422,31,1.84043690662053,-1.01042396235841 +-151.12868,57.7170213,13.719616,170594.01442182,860803.785551123,74.1498489379883,31,1.87011027059751,-0.902641834772733 +-151.06642,57.7155723,13.719616,174297.839466871,860803.774813547,75.9518127441406,31,1.88053814364163,-0.8647648234652 +-151.00416,57.7140923,13.719616,178001.9705817,860803.78464518,76.8000030517578,31,1.88536123728882,-0.847245970690605 +-150.94191,57.7125812,13.719616,181705.820977778,860803.77726695,79.1645812988281,31,1.89853091912745,-0.799409927251269 +-150.87966,57.711039,13.719616,185409.990903989,860803.779679452,81.8428802490234,31,1.9129809048469,-0.746923454681689 +-150.81742,57.7094658,13.719616,189113.892551422,860803.77533282,83.9259567260742,31,1.92389630075099,-0.707275621193871 +-150.75519,57.7078616,13.719616,192817.532374192,860803.763338455,89.0023727416992,31,1.94940158478976,-0.614633149632223 +-150.69296,57.7062263,13.719616,196521.511141682,860803.761260191,95.0999984741211,31,1.97818050996916,-0.510099879057571 +-150.63073,57.70456,13.719616,200225.834770209,860803.781069045,97.293212890625,31,1.98808254523281,-0.474132860657769 +-150.56851,57.7028626,13.719616,203929.916525781,860803.781735001,98.6194686889648,130,1.99396265844586,-0.452774611116564 +-150.5063,57.7011342,13.719616,207633.762300925,860803.773585496,105.68505859375,130,2.02401359252068,-0.343621041166275 +-150.44409,57.6993748,13.719616,211337.972303328,860803.78763144,108.77513885498,130,2.03652964635605,-0.298159161198768 +-150.38189,57.6975843,13.719616,215041.959825887,860803.781217304,112.02823638916,130,2.04932749912068,-0.251673707086771 +-150.3197,57.6957629,13.719616,218745.730106655,860803.775866121,121.549858093262,130,2.08475445615057,-0.122992887293986 +-150.25751,57.6939104,13.719616,222449.884575475,860803.782004966,138.933853149414,130,2.14280808047224,0.0878744463964008 +-150.19533,57.6920269,13.719616,226153.835304238,860803.777654676,162.981796264648,130,2.21213909996652,0.339704498242766 +-150.13316,57.6901124,13.719616,229857.588732103,860803.762080053,181.352783203125,134,2.25852422504181,0.508188512149044 +-150.07099,57.6881669,13.719616,233561.745057312,860803.769730247,203.231719970703,231,2.30799149265291,0.68786774747643 +-150.00883,57.6861904,13.719616,237265.716954995,860803.76584699,225.912414550781,231,2.35394009733362,0.854766194714262 +-149.94668,57.684183,13.719616,240969.510178091,860803.760888333,252.578903198242,330,2.40239707303159,1.03077576144713 +-149.88453,57.6821445,13.719616,244673.726271766,860803.768726912,298.026519775391,330,2.47425491132345,1.29178394039217 +-149.82239,57.6800751,13.719616,248377.776533129,860803.775271249,470.833892822266,430,2.6728677178415,2.01320234340466 +-135.63963,56.3554847,13.719616,1118817.90721983,860803.810756239,453.060272216797,351,2.6561559815933,1.95250054734679 +-135.58191,56.3464054,13.719616,1122521.90890391,860803.811782052,224.981918334961,250,2.35214761552068,0.848255389144417 +-135.52422,56.3372982,13.719616,1126225.82572092,860803.783381579,192.43424987793,150,2.28428237128397,0.601749451407463 +-135.46656,56.3281632,13.719616,1129929.65912039,860803.735062174,191.854263305664,150,2.28297145435296,0.596987826941071 +-135.40892,56.3190004,13.719616,1133634.00735109,860803.836310297,196.679534912109,150,2.29375917264363,0.636171898894154 +-135.35132,56.3098098,13.719616,1137337.68737387,860803.745080252,174.068237304688,150,2.24071953147474,0.443516783147937 +-135.29374,56.3005914,13.719616,1141041.89118676,860803.802133296,167.191101074219,150,2.22321315792828,0.379928637610713 +-135.23619,56.2913453,13.719616,1144746.0263908,860803.846292617,153.079498291016,150,2.18491703018037,0.240826170827173 +-135.17868,56.2820714,13.719616,1148449.50678095,860803.692734171,146.074295043945,150,2.16457379907771,0.166933748926095 +-135.12119,56.2727698,13.719616,1152153.52121042,860803.696295633,142.622741699219,150,2.15418878082447,0.129212398450982 +-135.06372,56.2634405,13.719616,1155858.07410509,860803.857480735,148.985061645508,150,2.17314272498836,0.198058533648509 +-135.00629,56.2540835,13.719616,1159561.98236361,860803.827594263,148.913696289062,150,2.17293464368375,0.197302722957853 +-134.94889,56.2446989,13.719616,1163265.84100586,860803.789667543,159.163711547852,150,2.20184405793073,0.302309967071222 +-134.89152,56.2352866,13.719616,1166969.65757721,860803.731855424,155.632659912109,150,2.1921007400266,0.266919455423629 +-134.83417,56.2258467,13.62799286,1170674.02706755,860803.839989128,131.708114624023,150,2.11961253295625,0.00362159714994989 +-134.77686,56.2163793,10.70409103,1174377.76314209,860803.771623772,40.228515625,50,1.60453400801832,-1.86729062347251 +-134.71957,56.2068842,11.12507459,1178082.06404232,860803.857366969,100.863121032715,50,2.00373240251352,-0.417288112100212 +-134.43359,56.1589959,10.48663109,1196602.01286121,860803.842703398,585.044372558594,350,2.76718880629848,2.35580345859934 +-134.37649,56.1493358,13.52677651,1200305.59906953,860803.718477543,287.317077636719,251,2.45836144048192,1.23405431784751 +-134.31941,56.1396482,13.719616,1204009.77394722,860803.765923755,87.0386734008789,151,1.93971226310929,-0.649827531583416 +-155.55427,57.7072012,13.719616,-92390.0044913771,857099.773895662,24.5690422058105,20,1.3903882263686,-2.64512922571571 +-155.49198,57.7079617,13.719616,-88686.0466998037,857099.767972447,32.0272903442383,20,1.50552019691157,-2.22693704676757 +-155.42969,57.7086912,13.71299415,-84982.2447057733,857099.7765446,26.9186401367188,20,1.43005311662043,-2.50105502283424 +-155.36739,57.7093896,9.83514901,-81277.9979428241,857099.775843017,11.298547744751,20,1.05302262516722,-3.87053738300854 +-155.3051,57.7100568,13.2506383,-77574.4887573525,857099.779386912,32.8758239746094,121,1.5168766464603,-2.18568718055318 +-155.24279,57.710693,13.719616,-73869.9272339864,857099.774132016,292.608459472656,121,2.46628687766484,1.2628417678409 +-155.18049,57.711298,13.719616,-70166.0902454097,857099.772469805,291.287902832031,232,2.46432244878013,1.25570640142779 +-155.11819,57.7118719,13.719616,-66462.3767420057,857099.773582905,289.374633789062,232,2.4614604587517,1.24531083675123 +-155.05588,57.7124148,13.719616,-62758.1857155363,857099.778901151,279.049041748047,232,2.44568053549181,1.18799365143282 +-154.99357,57.7129265,13.719616,-59054.1053373726,857099.776384242,261.092590332031,232,2.41679454695288,1.08307149617745 +-154.93126,57.7134071,13.719616,-55350.1289063172,857099.776942933,248.001739501953,232,2.39445472700948,1.00192689372359 +-154.86895,57.7138566,13.719616,-51646.2499087811,857099.780336626,238.997619628906,232,2.37839357547877,0.943588207054984 +-154.80664,57.7142749,13.719616,-47942.4619664192,857099.775172587,228.93440246582,232,2.35971105994593,0.875727978118876 +-154.74432,57.7146622,13.719616,-44238.1639646201,857099.776915341,225.801681518555,232,2.3537271717409,0.853992788186473 +-154.682,57.7150183,13.719616,-40533.9439679379,857099.770812256,221.191421508789,232,2.34476827966865,0.821451535057669 +-154.61969,57.7153433,13.719616,-36830.3896441354,857099.773398478,215.792053222656,232,2.33403544727416,0.782466824345523 +-154.55737,57.7156372,13.719616,-33126.3058409413,857099.772861989,211.370269775391,232,2.32504390170133,0.749806964382394 +-154.49505,57.7159,13.719616,-29422.2803612016,857099.775159145,208.013153076172,232,2.31809079711563,0.724551303913521 +-154.43273,57.7161317,13.719616,-25718.3066890531,857099.780158366,206.441131591797,232,2.31479623095753,0.712584499264469 +-154.37041,57.7163322,13.719616,-22014.3783707139,857099.776575244,208.471328735352,232,2.3190463344741,0.728022088336977 +-154.30809,57.7165016,13.719616,-18310.4888066669,857099.775477629,194.266464233398,121,2.28839783582666,0.616697993297028 +-154.24576,57.7166399,13.719616,-14606.0371620227,857099.774581311,168.540756225586,121,2.22670493822568,0.392611780304177 +-154.18344,57.7167471,13.719616,-10902.2055571418,857099.778773512,63.2450942993164,35,1.80102684445081,-1.15357255691049 +-154.12112,57.7168231,13.719616,-7198.39317726523,857099.774074909,101.370124816895,35,2.00590998124108,-0.409378524618869 +-154.05879,57.716868,13.719616,-3493.9991458539,857099.771089775,119.422515869141,35,2.0770862162058,-0.150846123506965 +-153.99647,57.7168818,13.719616,209.79441697091,857099.771405633,155.420303344727,35,2.19150775226804,0.264765554628961 +-153.93415,57.7168645,9.973640293,3913.58834649914,857099.773931727,16.9028701782227,35,1.22796045589932,-3.23511324956148 +-153.49789,57.7158718,8.663868504,29841.8928395466,857099.775832377,20.1838989257812,35,1.30500506271337,-2.95526524689271 +-152.43867,57.7071131,12.84816823,92809.8241061225,857099.781259128,27.8897762298584,30,1.44544502977241,-2.44514720097684 +-152.37638,57.7063179,13.719616,96513.9634771493,857099.782952389,26.4985847473145,30,1.42322267948983,-2.52586512009344 +-152.3141,57.7054916,13.719616,100217.678337747,857099.773707498,132.029357910156,30,2.12067051121146,0.00746447614990367 +-152.25182,57.7046342,13.71678493,103921.569513624,857099.767912938,34.0465850830078,30,1.53207355812896,-2.13048765974217 +-152.18954,57.7037458,13.719616,107625.643206877,857099.777161911,100.313903808594,30,2.00136113171298,-0.425901244475864 +-152.12726,57.7028262,13.719616,111329.906521649,857099.779570039,147.266006469727,130,2.16810250986783,0.179751033710138 +-152.06499,57.7018756,13.719616,115033.77102513,857099.780604052,128.763702392578,130,2.10979345563046,-0.0320440943410405 +-152.00272,57.7008938,13.719616,118737.838180197,857099.774617793,134.340927124023,130,2.12820834115977,0.0348440260330505 +-151.94046,57.699881,13.719616,122441.519510507,857099.765992338,123.023155212402,130,2.08998686131367,-0.103987298264466 +-151.87819,57.6988371,13.719616,126146.010480797,857099.780386655,49.6775360107422,31,1.69616004684091,-1.53447869779367 +-151.81594,57.6977622,13.719616,129849.53427,857099.772501015,57.3689956665039,31,1.75867724694862,-1.30739838281702 +-151.75368,57.6966561,13.719616,133553.881058128,857099.777531941,61.6768531799316,31,1.79012220743177,-1.19318131105693 +-151.69143,57.695519,13.719616,137257.867963011,857099.77869414,60.8503379821777,31,1.7842629947828,-1.21446364378378 +-151.62919,57.6943508,13.719616,140961.501850586,857099.763720492,59.9692878723145,31,1.77792889167652,-1.2374709141988 +-151.56694,57.6931516,13.719616,144665.977446394,857099.786249313,59.2404861450195,31,1.77261861381327,-1.25675935910235 +-151.50471,57.6919213,13.719616,148369.518679881,857099.770368245,63.1427001953125,31,1.80032314985348,-1.15612857654245 +-151.44247,57.6906599,13.719616,152073.915002038,857099.782042292,61.4679298400879,31,1.78864858689398,-1.19853392146335 +-151.38024,57.6893675,13.719616,155777.983830025,857099.787821407,64.4994735717773,31,1.80955617004914,-1.12259161182546 +-151.31802,57.688044,13.719616,159481.732076795,857099.775517687,67.6047744750977,31,1.8299773683524,-1.04841599079773 +-151.2558,57.6866895,13.719616,163185.76009173,857099.779849961,67.821891784668,31,1.8313698995704,-1.04335791994596 +-151.19358,57.6853039,13.719616,166890.074806395,857099.790335269,68.3607559204102,31,1.83480685642213,-1.03087391165532 +-151.13138,57.6838873,13.719616,170593.493591533,857099.767448399,73.207275390625,31,1.8645542436949,-0.922822910330984 +-151.06917,57.6824396,13.719616,174297.806352591,857099.776127551,78.4684753417969,31,1.89469521426238,-0.813342302140374 +-151.00697,57.6809609,13.719616,178001.830436951,857099.776319704,79.9855346679688,31,1.90301145221803,-0.78313535219482 +-150.94478,57.6794512,13.719616,181705.572299455,857099.767088529,81.4581146240234,31,1.9109343539717,-0.754357111604194 +-150.88259,57.6779104,13.719616,185409.633236177,857099.764275665,82.3720626831055,31,1.91577994131056,-0.736756555321141 +-150.8204,57.6763387,13.719616,189114.018661681,857099.79096101,84.8157043457031,31,1.92847627300226,-0.690639854723007 +-150.75823,57.6747359,13.719616,192817.547448493,857099.767548287,88.5282745361328,31,1.94708199966818,-0.623058544869285 +-150.69605,57.6731021,13.719616,196522.008477447,857099.791420447,92.1112670898438,31,1.96431275653412,-0.560471517784546 +-150.63389,57.6714372,13.719616,200225.625807105,857099.763462214,102.066635131836,130,2.0088837974616,-0.398576775294287 +-150.57173,57.6697414,13.719616,203929.593399863,857099.764878617,100.08130645752,130,2.00035296598581,-0.429563190156104 +-150.50957,57.6680146,13.719616,207633.918256342,857099.785359649,102.842666625977,130,2.01217332901645,-0.38662825776129 +-150.44742,57.6662567,13.719616,211338.013098976,857099.782790167,109.508079528809,130,2.03944616269514,-0.287565541398542 +-150.38528,57.6644679,13.719616,215041.883186181,857099.778676606,114.455657958984,130,2.05863726629523,-0.217857975436721 +-150.32315,57.6626481,13.719616,218745.535545374,857099.761083323,131.832138061523,130,2.12002129554914,0.00510633955978254 +-150.26102,57.6607973,13.719616,222449.570934181,857099.7627385,151.680633544922,134,2.18093013397401,0.226344625832211 +-150.19889,57.6589155,13.719616,226153.995790178,857099.784562924,213.142761230469,134,2.3286705876937,0.762980123065925 +-150.13678,57.6570028,13.719616,229857.627263123,857099.769418963,227.088150024414,134,2.35619447233827,0.862954728193835 +-150.07467,57.655059,13.719616,233561.661712414,857099.762950983,266.055877685547,231,2.4249728577663,1.11277745537408 +-150.01257,57.6530844,13.719616,237265.509273116,857099.76384399,306.434143066406,231,2.48633715299459,1.33567009075687 +-149.95047,57.6510787,13.719616,240969.772673816,857099.774245834,329.490051269531,330,2.51784230589824,1.45010579856885 +-149.88838,57.6490421,13.719616,244673.862674609,857099.780606168,355.408111572266,430,2.55072733559892,1.56955361276368 +-149.8263,57.6469745,13.719616,248377.786373165,857099.771116197,549.046508789062,430,2.73960913434979,2.25562621805962 +-135.59832,56.3144607,13.719616,1122522.07887484,857099.862481559,544.804992675781,450,2.73624107886362,2.24339247919511 +-135.54068,56.305361,13.719616,1126225.76006922,857099.760773848,218.685180664062,250,2.33981935380176,0.803475623745061 +-135.48306,56.2962336,13.719616,1129929.94529827,857099.816336305,199.480743408203,150,2.29990097804181,0.658480689146124 +-135.42547,56.2870784,13.719616,1133634.04778203,857099.848195795,191.640747070312,150,2.28248785519321,0.595231256759947 +-135.36791,56.2778954,13.719616,1137338.07200258,857099.855141092,186.267364501953,150,2.27013676977391,0.550368589166287 +-135.31038,56.2686847,13.719616,1141042.0193392,857099.846682478,185.23974609375,150,2.2677341770392,0.541641686585575 +-135.25288,56.2594462,13.719616,1144745.89734105,857099.810907666,184.218872070312,150,2.26533411889106,0.532923990346724 +-135.19541,56.2501799,13.719616,1148449.710473,857099.746631454,178.355606079102,150,2.25128676464693,0.481899990217952 +-135.13796,56.240886,13.719616,1152154.05126314,857099.847574346,162.263366699219,150,2.21022048263483,0.332735532466179 +-135.08055,56.2315644,13.719616,1155857.73860652,857099.755431058,158.932540893555,150,2.20121282661981,0.300017154778612 +-135.02316,56.2222152,13.719616,1159561.96241683,857099.827266654,171.72917175293,150,2.23484407533102,0.422175449411804 +-134.96581,56.2128383,13.719616,1163265.54159609,857099.702567599,171.680618286133,150,2.23472126868159,0.421729380608576 +-134.90848,56.2034338,13.719616,1166969.66602811,857099.740641169,165.957870483398,150,2.21999785346928,0.368249734076373 +-134.85118,56.1940017,13.719616,1170673.74576948,857099.76573262,153.114730834961,150,2.18501697523505,0.241189199792931 +-134.79391,56.184542,13.719616,1174377.78518954,857099.776699273,144.116317749023,150,2.15871315713003,0.145646224578375 +-134.73667,56.1750547,13.41628878,1178081.78865183,857099.772406848,77.0977935791016,50,1.88704194938517,-0.841141144633695 +-134.67946,56.1655399,9.513150461,1181785.75731586,857099.762410963,32.0408744812012,50,1.50570436063247,-2.22626811156769 +-134.62228,56.1559976,12.22692913,1185489.69550614,857099.745585311,441.101470947266,250,2.64453850602873,1.91030256013858 +-134.56513,56.1464278,13.719616,1189193.60754139,857099.72081185,563.812255859375,350,2.75113451210715,2.29748967974465 +-134.50801,56.1368305,13.719616,1192897.49773459,857099.686980743,557.503845214844,350,2.7462478671459,2.27973999045808 +-134.45091,56.1272057,13.719616,1196601.96471138,857099.823171436,567.509216308594,350,2.75397291883338,2.30779958313627 +-134.39385,56.1175535,13.719616,1200305.82089223,857099.779153045,386.583190917969,251,2.58724296647919,1.70218880671954 +-134.33682,56.1078739,13.719616,1204009.66486379,857099.733454851,115.609283447266,151,2.06299270941358,-0.202037762863616 +-134.27982,56.0981669,13.719616,1207713.50088849,857099.6849908,57.3350563049316,50,1.75842024333581,-1.30833189329488 +-133.54152,55.9694916,11.70943329,1255866.05022816,857099.857602175,111.136070251465,50,2.0458550361575,-0.264286683708663 +-155.55282,57.674045,13.09953318,-92390.4034036882,853395.78533768,27.2644577026367,20,1.43559686387523,-2.48091855046181 +-155.49058,57.6748048,13.719616,-88685.949515908,853395.766820865,27.3909549713135,20,1.4376071739678,-2.47361653040598 +-155.42835,57.6755336,13.65886591,-84982.2460756215,853395.773368227,15.4843215942383,20,1.18989218261286,-3.37338808390488 +-155.36611,57.6762314,13.64075663,-81278.0968557791,853395.778465683,19.1921939849854,20,1.28312462461082,-3.03474124337998 +-155.30387,57.676898,13.719616,-77574.0906958175,853395.772787234,297.275482177734,232,2.47315909220527,1.28780361257703 +-155.24163,57.6775336,13.719616,-73870.2206395071,853395.778331413,294.389709472656,232,2.46892262496794,1.27241555436292 +-155.17939,57.6781381,13.719616,-70166.4804087434,853395.783614695,289.186981201172,232,2.4611787377243,1.24428754556854 +-155.11714,57.6787115,13.719616,-66462.2686189601,853395.77832714,274.414733886719,232,2.43840742581719,1.16157564114243 +-155.05489,57.6792538,13.719616,-62758.1736374796,853395.773305256,260.942626953125,232,2.41654503018627,1.08216518006193 +-154.99264,57.6797651,13.719616,-59054.1887880152,853395.779444841,248.557632446289,232,2.39542710353784,1.00545884281846 +-154.93039,57.6802452,13.719616,-55350.3079050557,853395.774156523,238.434967041016,232,2.37736994603203,0.939870092731482 +-154.86813,57.6806943,13.719616,-51645.9292787705,853395.771757529,229.023513793945,232,2.35988007354825,0.876341883763775 +-154.80588,57.6811123,13.719616,-47942.236317818,853395.776967533,227.037673950195,232,2.35609792869581,0.862604054128108 +-154.74362,57.6814992,13.719616,-44238.032758765,853395.77458178,221.02082824707,232,2.34443320204051,0.820234437471617 +-154.68137,57.681855,13.719616,-40534.5018426192,853395.778287071,217.739120483398,232,2.33793646433611,0.796636431775679 +-154.61911,57.6821797,13.719616,-36830.4473052737,853395.775140641,214.687362670898,232,2.33180648093451,0.77437058238959 +-154.55685,57.6824734,13.719616,-33126.4574172695,853395.7828092,213.300064086914,232,2.32899098593508,0.764143900929377 +-154.49458,57.6827359,13.719616,-29421.9309878922,853395.774380027,211.922546386719,232,2.32617716365014,0.75392329524566 +-154.43232,57.6829673,13.719616,-25718.0511528974,853395.770307907,202.349212646484,232,2.30610151886372,0.681002823221874 +-154.37006,57.6831677,13.719616,-22014.2164611237,853395.776657113,178.84700012207,121,2.25248165993728,0.486240190969588 +-154.3078,57.683337,13.719616,-18310.420482817,853395.782159514,147.495315551758,121,2.16877822734924,0.18220543247159 +-154.24553,57.6834751,13.719616,-14606.0618699851,853395.773362904,68.8935699462891,35,1.83817868972825,-1.01862645067046 +-154.18327,57.6835822,13.719616,-10902.3237687521,853395.777490906,41.0163192749023,35,1.61295668503476,-1.83669705647744 +-154.121,57.6836582,13.719616,-7198.00996515659,853395.779480878,47.9620094299316,35,1.6808973701326,-1.58991709599989 +-154.05874,57.683703,13.719616,-3494.30370806611,853395.770852058,71.4842910766602,35,1.85421061455241,-0.960393923742204 +-153.99647,57.6837168,13.719616,209.991298603348,853395.772308447,159.925445556641,35,2.20391756934752,0.309841552376104 +-153.93421,57.6836995,13.69730711,3913.69179558733,853395.773169456,178.722991943359,35,2.25218042621477,0.48514602410876 +-153.87194,57.6836511,13.66823243,7617.99404876802,853395.774064678,134.772903442383,35,2.12960258457052,0.0399083160575858 +-153.80968,57.6835716,11.93816483,11321.7148192043,853395.773281923,89.5717010498047,35,1.9521708219484,-0.604574489853051 +-152.44013,57.6739569,9.758707343,92810.0216827954,853395.779074225,14.9072551727295,30,1.1733976855002,-3.43330080541626 +-152.3779,57.6731625,12.75725193,96514.061753124,853395.787271215,12.6835422515869,30,1.10324055997148,-3.68813151017383 +-152.31568,57.6723369,13.71661694,100217.676784061,853395.770020572,64.3779754638672,30,1.80873731502285,-1.12556592700544 +-152.25345,57.6714803,13.719616,103922.062475964,853395.779687515,51.1279640197754,30,1.70865849891504,-1.48908075244704 +-152.19123,57.6705927,13.719616,107626.035548259,853395.785960425,102.019943237305,30,2.0086850775589,-0.399298582701214 +-152.12902,57.6696739,13.719616,111329.603101205,853395.765281421,58.4416809082031,130,1.76672269868353,-1.27817500571529 +-152.0668,57.6687242,13.719616,115033.960445072,853395.78457025,85.7293014526367,31,1.93312928498299,-0.673738787107168 +-152.00459,57.6677433,13.719616,118737.925272091,853395.776725213,208.977249145508,31,2.32009900808052,0.731845699338454 +-151.94239,57.6667314,13.719616,122441.503421708,853395.762889448,182.047439575195,31,2.26018457513383,0.514219377594331 +-151.88018,57.6656885,13.719616,126145.891114091,853395.779883594,104.9755859375,31,2.02108830739869,-0.35424651168883 +-151.81798,57.6646145,13.719616,129849.905430595,853395.779633863,76.9087905883789,31,1.88597598200998,-0.84501304239774 +-151.75579,57.6635095,13.719616,133553.55249122,853395.772165079,66.4316482543945,31,1.82237502797832,-1.07602986096034 +-151.69359,57.6623734,13.719616,137258.028901161,853395.786529287,66.777458190918,31,1.82462988410039,-1.06783957992498 +-151.63141,57.6612063,13.719616,140961.556128997,853395.772450959,63.8821144104004,31,1.80537928225624,-1.13776326049173 +-151.56922,57.6600081,13.719616,144665.925675049,853395.781354881,64.2723922729492,31,1.80802446502018,-1.12815520168279 +-151.50704,57.6587789,13.719616,148369.953861171,853395.781990295,62.2943305969238,31,1.7944485233444,-1.17746689680876 +-151.44487,57.6575187,13.719616,152073.647148331,853395.773296387,64,31,1.80617997398389,-1.13485491959676 +-151.3827,57.6562274,13.719616,155777.607312651,853395.766525045,69.0379180908203,31,1.83908768630939,-1.01532471563429 +-151.32053,57.6549051,13.719616,159481.840393795,853395.773479552,69.5,31,1.84198480459011,-1.00480155511883 +-151.25837,57.6535518,13.719616,163185.757973217,853395.770246412,67.6999969482422,31,1.83058864910816,-1.04619564461589 +-151.19621,57.6521675,13.719616,166889.961383626,853395.780956154,68.0223159790039,31,1.83265141442085,-1.03870309222836 +-151.13406,57.6507522,13.719616,170593.862204139,853395.780610499,72.8528366088867,31,1.86244646618979,-0.930478959849137 +-151.07191,57.6493058,13.719616,174298.062257302,853395.783329169,78.1759643554688,31,1.89307324727571,-0.819233749191447 +-151.00977,57.6478285,13.719616,178001.972145754,853395.785343653,81.4731979370117,31,1.91101476331126,-0.754065041931802 +-150.94764,57.6463201,13.719616,181705.599316012,853395.763402533,82.3000030517578,31,1.9153998513163,-0.738137150668773 +-150.88551,57.6447808,13.719616,185409.544078805,853395.766814416,84.8201522827148,31,1.92849904783936,-0.690557130014075 +-150.82338,57.6432104,13.719616,189113.813919795,853395.774033689,86.3914642333984,31,1.93647083484624,-0.661601324230574 +-150.76126,57.6416091,13.719616,192817.819352901,853395.779118358,89.3098526000977,31,1.95089937259316,-0.609192756819063 +-150.69915,57.6399768,13.719616,196521.567347966,853395.770036295,97.9496536254883,31,1.99100290455939,-0.463525282030069 +-150.63704,57.6383134,13.719616,200225.659791356,853395.764922234,101.64673614502,130,2.00709343809491,-0.405079871533538 +-150.57494,57.6366191,13.719616,203929.507130213,853395.756203746,100.757499694824,130,2.00327738190851,-0.418940876813429 +-150.51284,57.6348939,13.719616,207633.710651465,853395.774313444,96.5401153564453,130,1.98470781342444,-0.486390849830125 +-150.45075,57.6331376,13.719616,211337.683081301,853395.765981263,105.942977905273,130,2.02507217616661,-0.33977596321439 +-150.38866,57.6313504,13.719616,215042.024552263,853395.78509165,117.940956115723,130,2.07166464416503,-0.170538820629757 +-150.32659,57.6295323,13.719616,218745.551718193,853395.766654927,138.597320556641,134,2.14175483432547,0.0840487557649736 +-150.26451,57.6276831,13.719616,222450.056868044,853395.786414172,183.379623413086,134,2.26335107653084,0.525721014477768 +-150.20245,57.6258031,13.719616,226153.759924112,853395.778250608,236.934417724609,134,2.3746281520785,0.929911114506362 +-150.14039,57.623892,13.719616,229857.858955048,853395.775524679,278.406158447266,231,2.44467883779945,1.18435519950119 +-150.07834,57.6219501,13.719616,233561.763569801,853395.777462915,345.261444091797,231,2.53814808268455,1.52386217570244 +-150.01629,57.6199772,13.719616,237266.076350547,853395.796784729,389.225555419922,330,2.59020134704723,1.71293448934853 +-149.95426,57.6179733,13.719616,240969.613972683,853395.761900677,405.779693603516,330,2.60829030988165,1.77863876546718 +-149.89223,57.6159386,13.719616,244673.571234058,853395.766436398,462.012084960938,430,2.66465333564965,1.98336536266574 +-135.55711,56.2734204,13.719616,1126225.7782416,853395.77285689,302.184722900391,351,2.48027250458352,1.31364155670487 +-135.49954,56.2643005,13.719616,1129929.7198002,853395.751976812,209.907821655273,250,2.32202862170977,0.738854606806474 +-135.442,56.2551529,13.719616,1133633.571742,853395.714430204,202.042449951172,250,2.30544262609365,0.678609536614235 +-135.38448,56.2459775,13.719616,1137337.93648223,853395.8195319,197.454315185547,150,2.29546662928955,0.642373868788766 +-135.327,56.2367743,13.719616,1141041.62874457,853395.724115568,188.692230224609,150,2.27575401759975,0.570772036591876 +-135.26954,56.2275435,13.719616,1144745.83654483,853395.791473574,185.796447753906,150,2.26903740645189,0.546375387791182 +-135.21211,56.2182849,13.719616,1148449.97564146,853395.827724494,193.680435180664,150,2.28708575225126,0.61193213124523 +-135.15471,56.2089987,13.719616,1152154.04424951,853395.853094345,196.534530639648,150,2.29343886590105,0.635008453380457 +-135.09734,56.1996848,13.719616,1155858.04989796,853395.855689327,161.529434204102,150,2.20825167185392,0.325584249755357 +-135.04,56.1903432,13.719616,1159561.99700658,853395.834334564,181.937759399414,150,2.25992284198263,0.513268688083117 +-134.98269,56.180974,13.719616,1163265.88683985,853395.798559992,185.372909545898,150,2.26804626651628,0.542775284645518 +-134.92541,56.1715773,13.719616,1166969.72061975,853395.757892609,181.17594909668,150,2.25810054506343,0.506649585537245 +-134.86816,56.1621529,13.719616,1170673.50902944,853395.689784733,174.559143066406,150,2.24194260124126,0.44795932163881 +-134.81093,56.152701,13.719616,1174377.84498774,853395.791305392,164.504302978516,150,2.21617726237951,0.354372256733063 +-134.75374,56.1432215,13.719616,1178081.5462644,853395.697508289,165.485641479492,150,2.21876031776886,0.363754651184591 +-134.69657,56.1337146,13.719616,1181785.80057872,853395.782851515,178.858016967773,150,2.25250841133896,0.486337359696117 +-134.63943,56.1241801,13.719616,1185490.02376055,853395.84800032,397.445251464844,350,2.59927731255403,1.74590098660768 +-134.58233,56.1146181,13.719616,1189193.62206615,853395.72344885,524.244567871094,350,2.71953393907857,2.18270737880334 +-134.52525,56.1050287,13.719616,1192897.786338,853395.776327141,534.757385253906,350,2.7281567910984,2.21402803854635 +-134.4682,56.0954118,13.719616,1196601.92921159,853395.816339546,534.459594726562,350,2.72791487801891,2.21314934119279 +-134.41118,56.0857675,13.719616,1200306.0517472,853395.853053084,315.450500488281,251,2.49893122078663,1.38141533968238 +-134.3542,56.0760958,13.719616,1204009.56333684,853395.704070014,146.720001220703,151,2.16648932193925,0.17389147470387 +-134.29724,56.0663967,13.719616,1207713.65799533,853395.730332763,96.7584228515625,50,1.98568878080967,-0.482827696290998 +-134.24031,56.0566703,12.73733073,1211417.74183476,853395.760676188,112.858299255371,50,2.05253350128071,-0.240028592157436 +-133.55952,55.9378262,13.719616,1255865.58006076,853395.711523002,90.1003112792969,50,1.9547262913858,-0.5952922954528 +-133.50298,55.9277459,12.8855574,1259569.87143819,853395.803435051,52.2561073303223,50,1.71813705506742,-1.45465193105232 +-155.6757,57.6392762,9.726777085,-99798.0453660054,849691.766639224,19.6664180755615,20,1.29372526730752,-2.99623668338091 +-155.61353,57.6400975,13.43897978,-96093.9611341506,849691.768495026,29.9539375305176,20,1.47645391972619,-2.33251406184633 +-155.55136,57.6408877,13.719616,-92390.0454909913,849691.76776316,114.388549804688,20,2.05838255412906,-0.218783162726334 +-155.48919,57.6416469,13.719616,-88686.2916847282,849691.775214159,49.7046432495117,20,1.69639696103613,-1.5336181578146 +-155.42701,57.6423751,13.719616,-84982.0978107123,849691.777673372,31.1000003814697,20,1.49276039435385,-2.27328429166744 +-155.36483,57.6430722,13.719616,-81278.0530610223,849691.777524368,221.454162597656,121,2.34528384798137,0.823324226327313 +-155.30265,57.6437382,13.719616,-77574.1509323214,849691.77441908,323.987121582031,232,2.51052774743804,1.42353723445854 +-155.24047,57.6443732,13.719616,-73870.3847120941,849691.779190872,293.117614746094,232,2.46704191791699,1.26558428954662 +-155.17828,57.6449771,13.719616,-70166.1526914087,849691.769791727,274.911895751953,232,2.43919353266869,1.16443100560431 +-155.11609,57.64555,13.719616,-66462.0436114884,849691.768767287,263.640960693359,232,2.42101288551655,1.0983937058744 +-155.0539,57.6460919,13.719616,-62758.0509981588,849691.775831997,250.305786132812,232,2.398470888987,1.01651474035268 +-154.99171,57.6466027,13.719616,-59054.168543524,849691.779549146,238.430877685547,232,2.37736249746118,0.939843037396129 +-154.92952,57.6470824,13.719616,-55350.3897410919,849691.779663633,233.113922119141,232,2.36756821139688,0.904267394843023 +-154.86732,57.6475311,13.719616,-51646.1125041643,849691.779326039,226.863021850586,232,2.35576371265447,0.861390086071198 +-154.80512,57.6479487,13.719616,-47941.9259261146,849691.776037863,223.606536865234,232,2.34948449547111,0.838582176994229 +-154.74293,57.6483352,13.719616,-44238.4189331843,849691.776251764,219.71272277832,232,2.34185520608954,0.810870420344393 +-154.68073,57.6486907,13.719616,-40534.394034974,849691.777061714,217.851257324219,232,2.33816007080101,0.797448634279821 +-154.61853,57.6490151,13.719616,-36830.4402924369,849691.774342071,219.459609985352,232,2.34135460305399,0.809052087232924 +-154.55632,57.6493085,13.719616,-33125.9556694174,849691.774110233,209.01416015625,232,2.32017570940964,0.732124300458581 +-154.49412,57.6495708,13.719616,-29422.1246393221,849691.775586178,193.35417175293,232,2.2863535467206,0.609272551765632 +-154.43192,57.649802,13.719616,-25718.3452590329,849691.773093097,171.037933349609,121,2.23309244031861,0.415813011080334 +-154.36971,57.6500022,13.43100738,-22014.0155230479,849691.774368356,98.0997467041016,121,1.99166788602263,-0.461109879550982 +-154.30751,57.6501713,11.753021,-18310.3198727545,849691.775331765,35.726619720459,35,1.55299192730798,-2.05450617218696 +-153.93427,57.6505336,13.719616,3913.78854301452,849691.781296115,199.416229248047,35,2.29976049994383,0.657970432597813 +-153.74765,57.6502953,8.549429756,15025.8477149627,849691.779149619,52.5018653869629,35,1.72017473412734,-1.44725049909519 +-153.68545,57.6501537,10.48636653,18729.5145706797,849691.773033919,37.444938659668,35,1.57339312348469,-1.98040320459202 +-152.37942,57.640006,13.63630271,96513.9908491402,849691.776334014,27.1523494720459,30,1.43380741472037,-2.48741834055188 +-152.31726,57.6391813,12.72075982,100217.498809289,849691.773264794,16.9612865447998,30,1.22945879120584,-3.22967086806075 +-152.25509,57.6383254,13.2147777,103921.778296801,849691.771433442,20.9042129516602,30,1.32023382090889,-2.89995005040625 +-152.19293,57.6374386,12.9176523,107625.644063508,849691.774020119,26.3648223876953,30,1.42102484995902,-2.53384826427234 +-152.13077,57.6365207,13.57343556,111329.698608358,849691.774229529,27.2222480773926,31,1.43492398740999,-2.48336262984161 +-152.06861,57.6355718,13.719616,115033.94810496,849691.783682774,71.4416732788086,31,1.85395161787437,-0.961334673601831 +-152.00646,57.6345918,13.719616,118737.803920747,849691.77381051,98.2938537597656,31,1.99252636257608,-0.457991647675254 +-151.94431,57.6335808,13.719616,122441.867640717,849691.773027835,206.147720336914,31,2.31417853656365,0.710340856918396 +-151.88217,57.6325388,13.719616,126145.550295425,849691.762843492,148.611633300781,130,2.17205280727506,0.194099641420321 +-151.82002,57.6314658,13.719616,129850.049216347,849691.781207937,120.517906188965,130,2.08105157787621,-0.136442798093114 +-151.75789,57.6303618,13.719616,133553.584564357,849691.769998088,107.656318664551,130,2.0320395249223,-0.314468563854418 +-151.69575,57.6292267,13.719616,137257.94949042,849691.777259879,83.3796844482422,31,1.92106024719893,-0.717576977185214 +-151.63362,57.6280607,13.719616,140961.95882307,849691.785102529,71.0088195800781,31,1.85131229318502,-0.970921454211843 +-151.5715,57.6268636,13.719616,144665.619807342,849691.770111633,62.9355735778809,31,1.79889619459401,-1.16131168533841 +-151.50938,57.6256355,13.719616,148369.533948518,849691.764711859,62.2000007629395,31,1.79379039001783,-1.1798574249008 +-151.44726,57.6243764,13.719616,152073.707704316,849691.769514298,65.6351852416992,31,1.81713671528699,-1.09505690781858 +-151.38515,57.6230863,13.719616,155777.552097429,849691.761688881,67.4604339599609,31,1.82904913059481,-1.05178761527872 +-151.32304,57.6217653,13.719616,159481.668567296,849691.775377102,67.8059768676758,31,1.83126797714502,-1.04372813128651 +-151.26093,57.6204132,13.719616,163186.064457949,849691.788918663,67.3680801391602,31,1.82845417097077,-1.05394867845162 +-151.19884,57.6190301,13.719616,166889.554915169,849691.763885407,67.1628952026367,31,1.8271294090775,-1.05876059177265 +-151.13674,57.6176161,13.719616,170593.932211502,849691.785838678,71.1890487670898,31,1.85241318990337,-0.966922683103557 +-151.07465,57.616171,13.719616,174298.012882164,849691.782349474,78.6843490600586,31,1.89588835633863,-0.809008469562799 +-151.01257,57.614695,13.719616,178001.802403687,849691.774776993,78.9000625610352,31,1.89707734756812,-0.804689714045385 +-150.95049,57.613188,13.719616,181705.903139706,849691.778385478,80.7384338378906,31,1.90708032072256,-0.768356060415664 +-150.88842,57.6116501,13.719616,185409.725580317,849691.777160797,87.1699829101562,31,1.9403669608414,-0.647449482551059 +-150.82635,57.6100811,13.719616,189113.872640881,849691.776359436,87.7998504638672,31,1.94349377623899,-0.636091996545052 +-150.76429,57.6084812,13.719616,192817.754275372,849691.770037145,91.3042678833008,31,1.96049107846361,-0.574352943352155 +-150.70223,57.6068504,13.719616,196521.972329516,849691.78690592,96.3437347412109,31,1.98382347762364,-0.489603009873177 +-150.64018,57.6051886,13.719616,200225.938344505,849691.786471822,101.773002624512,130,2.00763258776315,-0.403121526049854 +-150.57814,57.6034958,13.719616,203929.658760588,849691.767887216,98.9039001464844,130,1.9952134177721,-0.448231496241389 +-150.5161,57.6017721,13.719616,207633.734864927,849691.772736702,108.906982421875,130,2.03705572484373,-0.29624829397376 +-150.45407,57.6000174,13.719616,211337.578225648,849691.758900529,115.996940612793,130,2.0644465349812,-0.196757053438915 +-150.39204,57.5982319,13.719616,215041.789499713,849691.780259026,129.695114135742,134,2.11292361568428,-0.0206744595889264 +-150.33002,57.5964153,13.719616,218745.781475447,849691.771306172,153.381607055664,134,2.18577328377753,0.243936328291201 +-150.26801,57.5945679,13.719616,222449.558735165,849691.764721447,207.842025756836,134,2.31773336665201,0.723253014448824 +-150.206,57.5926895,13.719616,226153.72435679,849691.771500435,257.862365722656,231,2.411387962721,1.06343323905447 +-150.144,57.5907802,13.719616,229857.688687908,849691.769112472,306.872283935547,231,2.48695766563153,1.33792396976616 +-150.082,57.58884,13.719616,233562.053559188,849691.791998983,396.314514160156,231,2.5980399777196,1.74140663331853 +-150.02002,57.5868689,13.719616,237265.634497826,849691.76966693,471.240478515625,330,2.67324258831751,2.01456397997222 +-149.95804,57.5848668,13.719616,240969.62944434,849691.761168362,470.894409179688,430,2.67292353419548,2.0134050843339 +-135.57351,56.2414762,13.66848115,1126225.8908437,849691.799589684,689.391296386719,450,2.83846579610836,2.6147018300672 +-135.51599,56.2323639,13.719616,1129929.58087356,849691.71353478,228.6650390625,250,2.35919976975375,0.873870826204126 +-135.45849,56.2232238,13.719616,1133633.77598349,849691.767104731,211.524703979492,250,2.32536109594483,0.750959104411035 +-135.40102,56.214056,13.719616,1137337.88213886,849691.8002068,213.509719848633,250,2.32941765069847,0.765693669132249 +-135.34358,56.2048605,13.719616,1141041.90378777,849691.811616256,209.158706665039,250,2.32047594770164,0.733214851631632 +-135.28617,56.1956372,13.719616,1144745.8484733,849691.789406294,218.89338684082,250,2.34023264095613,0.80497680065362 +-135.22879,56.1863863,13.719616,1148449.71444008,849691.753793763,249.563735961914,250,2.39718147838283,1.01183123300391 +-135.17144,56.1771077,13.719616,1152153.50921055,849691.692866275,253.619003295898,250,2.40418179147052,1.03725836822669 +-135.11411,56.1678015,13.719616,1155857.82951566,849691.79018177,227.593780517578,250,2.35716038986802,0.866463216362172 +-135.05681,56.1584676,13.719616,1159562.08745091,849691.860920041,217.6728515625,250,2.33780426665329,0.796156252058671 +-134.99955,56.1491062,13.719616,1163265.68570286,849691.750139567,241.77995300293,250,2.38342028882775,0.961846664705328 +-134.94231,56.1397171,13.719616,1166969.82580407,849691.785036116,269.998138427734,250,2.43136076981325,1.13598017522023 +-134.8851,56.1303005,13.719616,1170673.91039288,849691.811231447,296.319091796875,250,2.47175963391312,1.28272038061478 +-134.82792,56.1208563,13.719616,1174377.94698504,849691.816872345,303.612762451172,350,2.48232002330257,1.3210787291125 +-134.77077,56.1113847,13.719616,1178081.93357716,849691.822181068,318.006286621094,350,2.5024357055752,1.39414462871402 +-134.71365,56.1018855,13.719616,1181785.88085688,849691.804635775,357.130004882812,350,2.55282633971284,1.57717779482084 +-134.65656,56.0923588,13.719616,1185489.78997437,849691.773784345,465.523529052734,350,2.6679416365086,1.99530940995998 +-134.5995,56.0828047,13.719616,1189193.66203744,849691.739171388,497.055908203125,350,2.69640524036016,2.09869734347021 +-134.54247,56.0732231,13.719616,1192897.50455146,849691.688990723,506.363708496094,350,2.70446257188157,2.12796387134735 +-134.48546,56.0636141,13.719616,1196601.91402843,849691.812978648,517.31591796875,350,2.7137558419885,2.16171968093909 +-134.42849,56.0539777,13.719616,1200305.70387443,849691.750214488,310.580291748047,251,2.49217389357982,1.35687079853404 +-134.37154,56.0443139,13.719616,1204010.06922552,849691.860510131,161.206771850586,151,2.20738328136218,0.322430007626045 +-134.31463,56.0346227,13.719616,1207713.82347629,849691.78073005,84.4187622070312,50,1.92643898000748,-0.698039884381382 +-134.25775,56.0249042,13.719616,1211417.56305186,849691.701180302,125.762954711914,50,2.09955273225772,-0.0692413246242844 +-134.20089,56.0151584,13.49079065,1215121.88760979,849691.803737861,54.088752746582,50,1.73310696699351,-1.4002769380985 +-134.14407,56.0053853,9.290474177,1218825.61050005,849691.72193602,13.5071754455566,50,1.13056454097916,-3.58888301211331 +-133.634,55.9162018,11.31296906,1252161.81322599,849691.785342241,11.3278102874756,50,1.05414596705893,-3.86645708462414 +-133.57748,55.9061567,13.719616,1255865.67048466,849691.734506733,44.5559883117676,50,1.64890608134669,-1.70611858809323 +-133.52099,55.8960846,12.08241197,1259569.55719399,849691.702107997,54.0032501220703,50,1.73241989811195,-1.40277256838533 +-133.46452,55.8859854,12.6624632,1263274.076247,849691.866729903,41.016357421875,50,1.61295708894745,-1.83669558935125 +-133.40809,55.8758592,11.40792246,1266978.03746327,849691.858101353,58.546314239502,50,1.76749955942835,-1.27535322575195 +-133.35169,55.8657059,10.15144259,1270682.04374219,849691.854269497,59.1935043334961,50,1.77227405153883,-1.25801090763095 +-155.67414,57.6061195,13.719616,-99798.4911050722,845987.785294974,32.4994010925293,20,1.51187535776022,-2.20385328862178 +-155.61202,57.60694,13.719616,-96093.9237783542,845987.768689478,30.2000007629395,20,1.48000695392869,-2.31960842748595 +-155.54991,57.6077295,13.719616,-92390.1205178525,845987.772332969,83.931266784668,20,1.92392377802123,-0.707175815905542 +-155.4878,57.608488,13.719616,-88686.4788651445,845987.780805241,58.0250587463379,20,1.76361558882115,-1.2894609155929 +-155.42568,57.6092155,13.719616,-84982.3963611419,845987.78093238,208.789672851562,121,2.31970901380102,0.730429128799877 +-155.36356,57.609912,13.719616,-81278.4625294626,845987.786264216,321.749908447266,232,2.50751843199957,1.41260654184189 +-155.30143,57.6105774,13.719616,-77574.075128587,845987.773607793,303.981231689453,232,2.48284677036755,1.32299202480106 +-155.23931,57.6112118,13.719616,-73870.4194328802,845987.777716396,283.654571533203,232,2.45278978728604,1.21381648313193 +-155.17718,57.6118152,13.719616,-70166.2969891678,845987.77547011,266.488494873047,232,2.42567846394042,1.11534041839857 +-155.11505,57.6123876,13.719616,-66462.2973187603,845987.778249501,253.391357421875,232,2.40379179804546,1.03584180079164 +-155.05292,57.6129289,13.719616,-62758.4141278352,845987.774603478,243.734466552734,232,2.38691694722023,0.974547526032485 +-154.99078,57.6134393,13.719616,-59054.044588819,845987.777702365,232.860427856445,232,2.36709569109464,0.90255106623457 +-154.92865,57.6139186,13.719616,-55350.3745569028,845987.783301852,227.8447265625,232,2.3576389813437,0.868201597205477 +-154.86651,57.6143668,13.719616,-51646.2055451547,845987.773936131,224.885467529297,232,2.35196139151497,0.847578970402058 +-154.80437,57.614784,13.719616,-47942.1269060098,845987.769440527,219.841674804688,232,2.34211002394779,0.811795991537814 +-154.74223,57.6151702,13.719616,-44238.13216645,845987.769607302,222.021957397461,232,2.34639592717585,0.827363615380685 +-154.68009,57.6155254,13.719616,-40534.2148531151,845987.774244137,226.428298950195,232,2.35493070392028,0.858364360584269 +-154.61795,57.6158495,13.719616,-36830.3685962294,845987.772007101,208.771957397461,232,2.31967216307812,0.730295276456055 +-154.5558,57.6161426,13.719616,-33125.9908053301,845987.768913569,186.015930175781,121,2.26955013825656,0.548237776053962 +-154.49366,57.6164047,13.719616,-29422.266989523,845987.775351441,147.426116943359,121,2.16857442680426,0.181465170721757 +-154.43151,57.6166357,13.719616,-25717.998763532,845987.770604495,79.9427947998047,35,1.90277932712294,-0.783978496795293 +-153.93433,57.6173666,13.719616,3913.87860990069,845987.776979342,80.5198364257812,35,1.90590288395814,-0.772632846817969 +-153.87218,57.6173183,10.15224004,7617.97500133247,845987.779024377,34.916675567627,35,1.54303288762905,-2.09068024689376 +-153.62359,57.6168146,7.995283691,22433.9629135386,845987.77361437,20.8850650787354,35,1.319835832883,-2.90139565651338 +-152.44305,57.6076416,9.054786844,92809.928249535,845987.775012568,22.3889541625977,30,1.35003380720024,-2.79170799443315 +-152.13252,57.6033664,13.19006436,111329.59932508,845987.768332513,37.4840393066406,31,1.57384638461867,-1.9787568307798 +-152.07042,57.6024184,13.719616,115033.733975385,845987.778950843,83.1488800048828,31,1.91985640375427,-0.721949680187336 +-152.00832,57.6014393,13.719616,118738.070087479,845987.784762492,98.0187835693359,31,1.99130930853773,-0.462412335324341 +-151.94623,57.6004292,13.719616,122442.017817764,845987.778980506,112.396392822266,130,2.05075237348817,-0.246498156684417 +-151.88415,57.5993882,13.719616,126145.583271718,845987.771595779,158.027069091797,130,2.1987314853739,0.291004215128166 +-151.82206,57.5983161,13.719616,129849.965594045,845987.778233947,146.425079345703,130,2.16561546803817,0.170717387912391 +-151.75998,57.5972131,13.719616,133553.9785389,845987.783204076,121.712409973145,130,2.08533486178046,-0.120884688381948 +-151.69791,57.5960791,13.719616,137257.628920491,845987.774219692,113.843185424805,130,2.05630703915863,-0.226322025509892 +-151.63584,57.5949141,13.719616,140961.519187996,845987.771397073,97.6750793457031,130,1.98978377269321,-0.467953516942924 +-151.57377,57.5937181,13.719616,144665.655797924,845987.775315369,72.4828948974609,31,1.86023553032116,-0.938509709987919 +-151.5117,57.5924911,13.719616,148370.045205767,845987.786569123,69.1843643188477,31,1.8400079549002,-1.01198203744166 +-151.44965,57.5912331,13.719616,152073.501882615,845987.759970486,69.1098251342773,31,1.83953979409305,-1.01368253111963 +-151.38759,57.5899442,13.719616,155777.819817693,845987.774326672,70.1370620727539,31,1.8459475700383,-0.990407659925159 +-151.32554,57.5886243,13.719616,159481.813898238,845987.772763286,70.5870208740234,31,1.84872485287918,-0.980319775931626 +-151.26349,57.5872735,13.719616,163186.086107054,845987.789992808,68.9086685180664,31,1.83827385837728,-1.01828077097336 +-151.20145,57.5858917,13.719616,166890.047341631,845987.790397895,68.0159072875977,31,1.83261049563716,-1.03885172093012 +-151.13942,57.5844789,13.719616,170593.704050786,845987.772991771,71.0105895996094,31,1.85132311860275,-0.970882133204753 +-151.07739,57.5830352,13.719616,174297.658182518,845987.774204728,76.8580017089844,31,1.88568908871481,-0.846055120733309 +-151.01536,57.5815605,13.719616,178001.916653652,845987.783596434,82.3350677490234,31,1.91558484719462,-0.737465192835643 +-150.95334,57.5800549,13.719616,181705.889405507,845987.785693912,84.6835250854492,31,1.92779892791722,-0.693100165405411 +-150.89133,57.5785183,13.719616,185409.583373206,845987.768415137,89.1835556030273,31,1.95028478297201,-0.611425121744408 +-150.82932,57.5769508,13.719616,189113.600458002,845987.770480434,90.8928756713867,31,1.95852984386158,-0.581476707218829 +-150.76731,57.5753523,13.719616,192817.947613197,845987.78151252,95.245719909668,31,1.97884546874264,-0.507684558994167 +-150.70531,57.5737229,13.719616,196522.034733167,845987.783866453,97.1061019897461,31,1.98724652112542,-0.477169538840835 +-150.64332,57.5720626,13.719616,200225.868225106,845987.776676054,101.76439666748,130,2.00759586213273,-0.403254924022108 +-150.58133,57.5703714,13.719616,203930.050486477,845987.78979759,107.554588317871,130,2.0316289422793,-0.315959917205753 +-150.51935,57.5686492,13.719616,207633.992514967,845987.781651798,112.877128601074,134,2.05260595318632,-0.239765426156435 +-150.45738,57.5668962,13.719616,211337.699553857,845987.773722129,121.232093811035,134,2.08361760596843,-0.12712225164484 +-150.39541,57.5651122,13.719616,215041.775176635,845987.775280727,140.406524658203,134,2.14738728982523,0.104507441802933 +-150.33345,57.5632973,13.719616,218745.629206501,845987.765424156,179.147506713867,134,2.25321076824902,0.488888520466063 +-150.27149,57.5614515,13.719616,222449.864033466,845987.776873262,233.655090332031,231,2.36857524685843,0.907925235075927 +-150.20954,57.5595748,13.719616,226153.890062626,845987.77648772,299.117004394531,231,2.47584110278323,1.29754544051823 +-150.1476,57.5576673,13.719616,229857.713041741,845987.774670957,322.771545410156,231,2.50889524161371,1.41760750734103 +-150.08566,57.5557288,13.719616,233561.936640478,845987.783565489,396.764404296875,330,2.59853270251723,1.74319635042115 +-150.02373,57.5537595,13.719616,237265.969953842,845987.790698894,497.898376464844,330,2.69714071014068,2.10136877963702 +-149.96181,57.5517592,13.719616,240969.820698087,845987.773077327,576.332763671875,430,2.76067330928714,2.33213731374617 +-135.53241,56.2004238,13.719616,1129929.53300694,845987.702416362,413.330780029297,351,2.61629774764593,1.80772406497732 +-135.47495,56.1912913,13.719616,1133634.06452617,845987.858365824,246.678436279297,250,2.39213118672433,0.993487132203485 +-135.41753,56.182131,13.719616,1137337.91036977,845987.809291468,243.104614257812,250,2.38579320206706,0.970465762887365 +-135.36014,56.172943,13.719616,1141041.66791632,845987.734825808,261.658630371094,250,2.41773506378705,1.08648772176939 +-135.30277,56.1637274,13.719616,1144745.93450179,845987.816829789,283.982604980469,250,2.45329173866548,1.21563971381324 +-135.24544,56.1544841,13.719616,1148449.52565874,845987.699184592,306.883605957031,350,2.48697368858637,1.33798216971157 +-135.18813,56.1452131,13.719616,1152153.63780131,845987.725987745,301.745056152344,250,2.47964016326534,1.31134471254907 +-135.13085,56.1359146,13.719616,1155857.67311196,845987.745074601,290.189392089844,250,2.46268153270183,1.24974612586731 +-135.0736,56.1265884,13.719616,1159561.64222423,845987.733839879,281.200622558594,250,2.44901627784659,1.20011001978102 +-135.01638,56.1172346,13.719616,1163265.54640791,845987.701800359,302.700347900391,350,2.48101292010138,1.31633095720137 +-134.95918,56.1078533,13.719616,1166969.98288204,845987.834189162,317.082458496094,350,2.50117221683292,1.38955527696646 +-134.90202,56.0984444,13.719616,1170673.7671726,845987.768253902,314.660583496094,350,2.49784234366861,1.37746022719328 +-134.84489,56.089008,13.719616,1174377.49646883,845987.688681062,344.764709472656,350,2.53752280452599,1.5215909869584 +-134.78778,56.0795441,13.719616,1178081.77109816,845987.771699289,361.085784912109,350,2.55761039162332,1.59455483686407 +-134.7307,56.0700527,13.719616,1181785.99939889,845987.839876262,393.993225097656,350,2.59548875398801,1.73213986053363 +-134.67366,56.0605338,13.719616,1185489.58970365,845987.713556864,430.509124755859,350,2.63398236087474,1.87195962791551 +-134.61664,56.0509875,13.719616,1189193.73510639,845987.758737228,440.976226806641,350,2.64441517712092,1.90985459434388 +-134.55965,56.0414138,13.719616,1192897.84390085,845987.796327798,477.940368652344,350,2.67937371422561,2.03683397926797 +-134.50269,56.0318126,13.719616,1196601.92359286,845987.814526074,474.14990234375,350,2.67591566544767,2.02427335908113 +-134.44576,56.0221841,13.719616,1200305.97201318,845987.833554262,242.77214050293,151,2.38519884747716,0.968306897371148 +-134.38886,56.0125282,13.719616,1204009.99664704,845987.84162315,178.126281738281,151,2.25072800240443,0.479870406266589 +-134.33199,56.0028449,13.719616,1207714.00175687,845987.83762573,69.8594741821289,50,1.84422531246883,-0.996663390998718 +-134.27515,55.9931343,13.719616,1211417.98833681,845987.831122603,102.158782958984,50,2.00927571043639,-0.397153235506754 +-134.21834,55.9833965,13.719616,1215121.9573389,845987.831670661,123.745933532715,50,2.09253093630605,-0.0947464917408378 +-134.16156,55.9736313,13.719616,1218825.91951516,845987.816861814,89.8046112060547,50,1.95329863700059,-0.600477943673025 +-134.10481,55.9638388,12.27690977,1222529.8758152,845987.796271728,38.2303085327148,50,1.5824078029501,-1.94765931572797 +-134.04809,55.9540192,13.719616,1226233.82384778,845987.790120043,196.95263671875,251,2.29436179933525,0.638360811044901 +-133.9914,55.9441722,13.719616,1229937.77768268,845987.765386206,216.422698974609,151,2.3353028087563,0.787070242989662 +-133.93474,55.9342981,12.23959101,1233641.73159122,845987.752944454,74.7028579711914,50,1.87333721730904,-0.890920643254179 +-133.82151,55.9144684,10.99312362,1241049.66283241,845987.739391459,61.3053207397461,50,1.78749816893329,-1.20271256785857 +-133.65189,55.8845202,13.27808599,1252161.67701218,845987.74227955,102.761558532715,50,2.01183068236956,-0.387872848183883 +-133.59541,55.8744832,13.719616,1255865.7281855,845987.749535845,106.762466430664,50,2.02841859831943,-0.32762080279139 +-133.53896,55.8644193,13.71528852,1259569.80154907,845987.783012367,96.7404708862305,50,1.9856081969949,-0.483120399707147 +-133.48254,55.8543282,13.70646488,1263273.91131006,845987.809820106,80.3393630981445,50,1.90492838447733,-0.776172507082094 +-133.42615,55.8442102,13.719616,1266978.05139032,845987.860803481,76.4235000610352,50,1.88322692372645,-0.8549984067429 +-133.3698,55.8340651,12.15461068,1270681.6366408,845987.722382527,66.8979797363281,50,1.82541300263161,-1.06499506989532 +-155.67257,57.5729617,13.719616,-99798.1666175125,842283.775555802,30.3481063842773,20,1.48213159779956,-2.31189111451322 +-155.61052,57.5737815,13.719616,-96094.3145851346,842283.781290539,59.6133193969727,20,1.77534330494728,-1.24686250319934 +-155.54846,57.5745703,13.719616,-92390.0338457173,842283.774975025,41.9114608764648,20,1.62233279897582,-1.80264033443416 +-155.4864,57.5753281,13.719616,-88685.9144852256,842283.771244533,218.529708862305,121,2.33951048715491,0.802353731924377 +-155.42434,57.5760549,13.719616,-84981.9500395431,842283.769722342,308.618377685547,232,2.48942178397529,1.3468743509201 +-155.36228,57.5767507,13.719616,-81278.1340439113,842283.770047161,310.127044677734,232,2.49153964060741,1.35456701070443 +-155.30022,57.5774156,13.719616,-77574.4598143345,842283.783038092,288.237854003906,232,2.45975101570579,1.23910165168486 +-155.23815,57.5780494,13.719616,-73870.3247831161,842283.77491157,271.619903564453,232,2.43396159068762,1.14542709898415 +-155.17608,57.5786523,13.719616,-70166.3186063395,842283.779921351,258.561370849609,232,2.41256364165809,1.06770364052615 +-155.11401,57.5792241,13.719616,-66462.4352228817,842283.77543704,246.022277832031,232,2.39097443515807,0.989285480345073 +-155.05193,57.579765,13.719616,-62758.0712307008,842283.774055325,236.035736083984,232,2.37297776063599,0.923916421718547 +-154.98986,57.5802749,13.719616,-59054.4134583287,842283.783799489,230.539520263672,232,2.36274538508892,0.886749513120849 +-154.92778,57.5807537,13.719616,-55350.2624944436,842283.77490767,226.860534667969,232,2.35575895129848,0.861372791467226 +-154.8657,57.5812016,13.719616,-51646.2080970826,842283.778923742,225.016189575195,232,2.35221376606794,0.848495666813287 +-154.80362,57.5816184,13.719616,-47942.2440984872,842283.773292622,233.858535766602,232,2.3689532261525,0.909298163758007 +-154.74154,57.5820043,13.719616,-44238.3637482611,842283.78013962,229.130752563477,232,2.3600833815173,0.877080356337263 +-154.67945,57.5823591,13.719616,-40533.9642867567,842283.770836386,211.380889892578,121,2.32506572190542,0.749886221591774 +-154.61737,57.582683,13.719616,-36830.2321034918,842283.780304354,175.230407714844,121,2.243609471449,0.454013870005455 +-154.55528,57.5829758,13.719616,-33125.9678470352,842283.77439979,76.710823059082,121,1.88485664247876,-0.849078803066463 +-154.4932,57.5832376,10.90647586,-29422.3580310326,842283.774677496,34.3364143371582,35,1.53575494094452,-2.11711582658478 +-154.43111,57.5834684,7.295419467,-25718.2030854837,842283.771588867,17.621374130249,35,1.24603977206214,-3.16944401290753 +-153.93439,57.5841986,13.719616,3913.96198418475,842283.77238873,135.958801269531,35,2.13340732681185,0.0537282258596598 +-153.8723,57.5841504,13.52732772,7617.9454008195,842283.78057976,113.770866394043,35,2.05603106536174,-0.22732444111097 +-153.81021,57.5840711,7.019932658,11321.9421485069,842283.778771237,31.5708293914795,35,1.49928599131292,-2.24958146092131 +-152.13426,57.5702111,13.71938476,111329.901457901,842283.776524208,72.9088897705078,31,1.86278048501064,-0.929265708153341 +-152.07222,57.5692639,13.719616,115033.914900647,842283.777540365,77.1339569091797,31,1.88724561088727,-0.840401387927287 +-152.01019,57.5682857,13.719616,118737.532651041,842283.763667808,77.3221817016602,31,1.88830409946444,-0.836556655292271 +-151.94815,57.5672766,13.719616,122441.953921734,842283.781754952,80.3126907348633,31,1.90478417641995,-0.776696311907581 +-151.88612,57.5662365,13.719616,126145.992395932,842283.784824589,134.123886108398,130,2.12750612819686,0.0322933881202273 +-151.8241,57.5651654,13.719616,129849.654530681,842283.771720181,153.526916503906,130,2.18618452746359,0.245430082739593 +-151.76208,57.5640634,13.719616,133553.542955283,842283.77257138,149.203277587891,130,2.17377836350327,0.20036735416398 +-151.70006,57.5629304,13.719616,137257.664480323,842283.776764124,132.100860595703,130,2.12090564691617,0.00831855614385179 +-151.63804,57.5617664,13.719616,140962.025560028,842283.784861109,123.601890563965,130,2.09202511359437,-0.0965837842058469 +-151.57603,57.5605715,13.719616,144666.035690718,842283.786816467,107.722320556641,130,2.03230570042169,-0.313501738466557 +-151.51403,57.5593456,13.719616,148369.701711277,842283.770389968,87.7275009155273,130,1.94313575783166,-0.637392421589091 +-151.45203,57.5580888,13.719616,152073.626193953,842283.768574631,72.0758743286133,31,1.85778991937504,-0.947392866991079 +-151.39003,57.5568011,13.719616,155777.815557605,842283.781993138,75.8397369384766,31,1.87989681791695,-0.867094301549806 +-151.32804,57.5554824,13.719616,159481.680119742,842283.776111175,73.8696136474609,31,1.86846582758177,-0.908614921176649 +-151.26605,57.5541327,13.719616,163185.822877663,842283.774482094,77.3881149291992,31,1.8886742679568,-0.835212097671429 +-151.20407,57.5527522,13.719616,166889.652788708,842283.774959901,74.700439453125,31,1.87332315672177,-0.890971715320424 +-151.14209,57.5513407,13.719616,170593.77374618,842283.779928152,75.6278686523438,31,1.8786818612639,-0.871507370896861 +-151.08012,57.5498982,13.719616,174297.595645025,842283.763841873,80.4684906005859,31,1.90562585506146,-0.77363909484263 +-151.01815,57.5484249,13.719616,178001.72047534,842283.774857671,83.4753570556641,31,1.92155828537209,-0.715767960386067 +-150.95619,57.5469206,13.719616,181705.559090389,842283.764032492,84.0555038452148,31,1.92456615574512,-0.704842516659515 +-150.89423,57.5453854,13.719616,185409.713958146,842283.769512312,89.8390197753906,31,1.95346500473536,-0.599873648574285 +-150.83228,57.5438193,13.719616,189113.59493726,842283.763580712,89.0391845703125,31,1.9495811740329,-0.613980830241233 +-150.77033,57.5422223,13.719616,192817.804983883,842283.774373465,97.3868942260742,31,1.98850051593136,-0.472614671779898 +-150.70839,57.5405944,13.719616,196521.753953981,842283.773089042,99.3277053833008,31,1.99707040274364,-0.441486396788476 +-150.64645,57.5389356,13.719616,200226.044800968,842283.789009092,100.999298095703,130,2.00431835562203,-0.415159763162461 +-150.58452,57.5372459,13.719616,203930.087378021,842283.792246953,111.384506225586,134,2.04682478393728,-0.260764282978934 +-150.5226,57.5355253,13.719616,207633.888086297,842283.781965127,114.722312927246,134,2.05964789426353,-0.214187086193917 +-150.46068,57.5337738,13.719616,211338.049874905,842283.789163988,125.545921325684,134,2.098802608132,-0.0719659895556393 +-150.39877,57.5319914,13.719616,215041.982592639,842283.782329143,163.000396728516,134,2.21218866143951,0.33988451965893 +-150.33687,57.5301782,13.719616,218745.692020571,842283.771818241,226.746170043945,231,2.35553996015186,0.860577353116391 +-150.27497,57.5283341,13.719616,222449.781698113,842283.779199437,286.492828369141,231,2.45711375496417,1.22952236792216 +-150.21308,57.5264591,13.719616,226153.661469446,842283.771330497,334.948669433594,330,2.524978256918,1.4760256094758 +-150.15119,57.5245532,13.719616,229857.934275983,842283.782076134,408.263977050781,330,2.61094106187685,1.78826705331367 +-150.08931,57.5226165,13.719616,233562.009301524,842283.788356145,507.479644775391,330,2.70541862719803,2.13143653714209 +-150.02744,57.5206489,13.719616,237265.893571216,842283.778305548,607.10546875,330,2.78326414497516,2.41419367703151 +-135.5488,56.1684802,13.44282972,1129929.58069095,842283.720024633,603.151550292969,450,2.78042644843616,2.40388635324265 +-135.49139,56.1593552,13.719616,1133633.85145262,842283.797480317,331.417541503906,351,2.52037549133962,1.45930705113503 +-135.43401,56.1502025,13.719616,1137338.02566205,842283.848192855,283.673004150391,250,2.45281800796234,1.21391898868323 +-135.37667,56.1410221,13.719616,1141041.51121744,842283.699108788,305.093963623047,250,2.48443361507887,1.32875589772316 +-135.31935,56.131814,13.719616,1144745.50565951,842283.692070662,319.804534912109,350,2.50488461786344,1.40303977713407 +-135.26205,56.1225783,13.719616,1148450.01032025,842283.838239157,334.328033447266,350,2.52417279376581,1.47309993740498 +-135.20479,56.113315,13.719616,1152153.83650376,842283.791089975,338.571990966797,350,2.52965102739459,1.49299844558826 +-135.14756,56.104024,13.719616,1155857.5882794,842283.71108035,337.375701904297,350,2.52811380110765,1.48741480094604 +-135.09035,56.0947055,13.719616,1159561.86035207,842283.793018827,325.350524902344,350,2.51235151173687,1.43016166694607 +-135.03317,56.0853594,13.719616,1163266.06367173,842283.851515758,373.638519287109,350,2.57245164232119,1.64846249551344 +-134.97603,56.0759858,13.719616,1166969.60291899,842283.720359299,345.606353759766,350,2.53858171811658,1.52543726336345 +-134.91891,56.0665846,13.719616,1170673.67869903,842283.738551149,309.213500976562,350,2.49025844796173,1.34991335332654 +-134.86182,56.057156,13.719616,1174377.69249423,842283.75113717,338.03955078125,350,2.52896751590243,1.49051573675513 +-134.80476,56.0476998,13.719616,1178081.65496804,842283.735566165,353.181976318359,350,2.54799853243326,1.55964182078803 +-134.74773,56.0382162,13.719616,1181785.56410423,842283.712050634,352.255798339844,350,2.54685815058557,1.55549962841986 +-134.69072,56.0287051,13.719616,1185490.0239449,842283.847255504,378.090179443359,350,2.57759539709555,1.66714608102769 +-134.63375,56.0191666,13.719616,1189193.84250464,842283.79425424,428.705596923828,350,2.63215915343661,1.86533721810501 +-134.57681,56.0096006,13.719616,1192897.62383235,842283.719176159,420.900024414062,350,2.62417895093902,1.83635084485721 +-134.51989,56.0000073,13.719616,1196601.96233792,842283.822416109,304.632446289062,251,2.48377615800805,1.32636782598502 +-134.46301,55.9903867,13.719616,1200305.66916909,842283.743030825,104.871086120605,50,2.02065576589452,-0.355817625891617 +-134.40615,55.9807386,13.719616,1204009.94814846,842283.819477901,64.1396484375,50,1.80712657514228,-1.13141659400261 +-134.34933,55.9710633,13.719616,1207713.6007153,842283.720605407,37.0261306762695,50,1.56850832955562,-1.99814617040139 +-134.29253,55.9613606,13.719616,1211417.83068983,842283.787120813,118.94352722168,50,2.07534081317956,-0.157185925485897 +-134.23576,55.9516306,13.719616,1215122.04250485,842283.847286655,96.6122741699219,50,1.9850323051488,-0.485212203268067 +-134.17903,55.9418734,13.71409304,1218825.64055114,842283.727130707,31.3783874511719,50,1.49663062124415,-2.25922652292916 +-134.12232,55.9320889,11.31524669,1222529.82539932,842283.781399448,25.7068538665771,50,1.41004892876298,-2.57371594289616 +-134.06564,55.9222772,13.719616,1226234.00141054,842283.8366883,328.418853759766,251,2.5164280809955,1.44496893006212 +-134.009,55.9124383,13.719616,1229937.57620891,842283.706712477,199.550811767578,151,2.30005349882244,0.659034688155131 +-133.95238,55.9025722,9.613866903,1233641.74706102,842283.760239516,45.162670135498,50,1.65477961064071,-1.68478425322519 +-133.83924,55.8827585,10.18165971,1241049.50403905,842283.683369435,21.2466869354248,50,1.3272912187233,-2.87431556716241 +-133.78271,55.872811,13.70270585,1244753.69166208,842283.747802226,41.630126953125,50,1.61940773529124,-1.81326500063286 +-133.72621,55.8628363,13.62471381,1248457.89536675,842283.80685532,138.644897460938,50,2.14190389089667,0.0845901717765584 +-133.66975,55.8528346,11.96016802,1252161.5160246,842283.692198723,84.0944442749023,50,1.92476730494829,-0.70411188533991 +-133.61331,55.8428058,13.08343621,1255865.75418156,842283.768696466,109.161994934082,50,2.03807146379657,-0.292558840176307 +-133.50053,55.822667,11.06000195,1263273.70980481,842283.747466041,41.8137016296387,50,1.62131861591603,-1.80632413678397 +-133.44418,55.8125571,12.95160628,1266978.02859101,842283.847969393,55.7669868469238,50,1.74637717970573,-1.35207573783192 +-133.38787,55.8024203,10.80525422,1270681.7813006,842283.777433334,18.9766674041748,50,1.27821994597028,-3.05255643613708 +-155.98094,57.5352434,11.52008883,-118318.437010226,838579.78190757,31.5152244567871,20,1.49852040459179,-2.25236229041264 +-155.85697,57.53716,12.3429482,-110909.914158504,838579.763151692,26.7642192840576,20,1.42755457947469,-2.51013042290105 +-155.79499,57.5380719,11.25327211,-107206.244284618,838579.772725072,25.9766998291016,20,1.4145839759499,-2.55724335708191 +-155.733,57.5389529,10.81696956,-103502.163957147,838579.776522109,19.2492656707764,20,1.28441416650879,-3.03005725913464 +-155.67101,57.5398029,13.719616,-99798.2641374612,838579.77964368,30.3165664672852,20,1.48168001329412,-2.31353139833201 +-155.60901,57.5406219,13.719616,-96093.9412596716,838579.767198234,85.3987350463867,20,1.93145143782668,-0.679833206884151 +-155.54702,57.54141,13.719616,-92390.3828185253,838579.779439853,235.470458984375,121,2.37193643034047,0.920134012859972 +-155.48502,57.5421671,13.719616,-88686.3884205113,838579.776432581,301.701263427734,232,2.47957712886423,1.31111575361242 +-155.42301,57.5428933,13.719616,-84981.9513655592,838579.770637958,308.893707275391,232,2.48980906102592,1.34828105170788 +-155.36101,57.5435885,13.719616,-81278.2596666184,838579.776682125,294.720672607422,232,2.46941059965872,1.27418801772166 +-155.299,57.5442527,13.719616,-77574.1126473157,838579.769184866,276.704467773438,232,2.44201617147809,1.17468363542136 +-155.23699,57.544886,13.719616,-73870.1007441627,838579.771777584,261.098663330078,232,2.41680464849909,1.08310818787656 +-155.17498,57.5454883,13.719616,-70166.2177227785,838579.772981314,251.69450378418,232,2.40087373202725,1.02524255211456 +-155.11297,57.5460597,13.719616,-66462.4569322751,838579.783662184,240.438003540039,232,2.38100311317803,0.95306679281491 +-155.05095,57.5466,13.719616,-62758.2151859438,838579.771756103,233.073638916016,232,2.36749315674362,0.903994774919648 +-154.98893,57.5471094,13.719616,-59054.0827623543,838579.769890831,233.14111328125,232,2.3676188659562,0.904451386660718 +-154.92691,57.5475879,13.719616,-55350.0532275982,838579.777813842,227.382553100586,232,2.3567571385275,0.864998492394028 +-154.86489,57.5480353,13.719616,-51646.120438195,838579.772956082,225.535537719727,232,2.35321498355125,0.852132374488613 +-154.80287,57.5484518,13.719616,-47942.2776268496,838579.777426959,259.025787353516,232,2.41334300248991,1.07053450151906 +-154.74084,57.5488373,13.719616,-44237.921375872,838579.773192549,196.674209594727,121,2.29374741347781,0.636129186247495 +-154.67882,57.5491918,13.719616,-40534.239432834,838579.77394158,172.414733886719,121,2.2365743761771,0.428460395961792 +-154.61679,57.5495154,13.719616,-36830.0310126618,838579.777899543,108.733932495117,35,2.03636509510482,-0.298756858310831 +-154.55477,57.5498079,13.46344971,-33126.4840801636,838579.774222343,20.278356552124,35,1.30703275493815,-2.94790008997133 +-153.93445,57.5510297,12.82569191,3914.03865386396,838579.779690096,98.3002090454102,35,1.99255444140458,-0.457889657355629 +-153.74836,57.550792,7.098272948,15025.676319922,838579.771491842,25.7785625457764,35,1.4112586967318,-2.56932172033125 +-152.19799,57.5379702,13.50562181,107625.721020523,838579.774737104,49.3118438720703,31,1.69295124200576,-1.546133992839 +-152.136,57.5370548,13.719616,111330.009544777,838579.783044904,51.6577072143555,31,1.71313512645497,-1.47282036346529 +-152.07402,57.5361084,13.719616,115033.895093016,838579.774297237,70.609001159668,31,1.84886006797527,-0.979828636108407 +-152.01204,57.5351311,13.719616,118737.980894502,838579.776331534,66.8594970703125,31,1.82516310542422,-1.06590276788032 +-151.95007,57.5341229,13.719616,122441.676266326,838579.771194864,90.3809356689453,31,1.95607683305356,-0.59038674263253 +-151.8881,57.5330837,13.719616,126145.585094081,838579.765546981,105.612533569336,130,2.0237154611618,-0.344703939356888 +-151.82613,57.5320136,13.719616,129849.713466061,838579.771064197,121.263580322266,130,2.08373038668675,-0.126712599885095 +-151.76416,57.5309126,13.719616,133554.067803873,838579.788276412,142.703231811523,130,2.15443380872795,0.130102409734351 +-151.7022,57.5297806,13.719616,137258.057807324,838579.785900826,168.173461914062,130,2.22575746438939,0.389170284894817 +-151.64025,57.5286177,13.719616,140961.689530666,838579.773985348,171.353530883789,130,2.23389305786158,0.418721082515376 +-151.5783,57.5274239,13.719616,144665.566499782,838579.773215853,153.585006713867,130,2.18634882103888,0.246026843899096 +-151.51635,57.5261991,13.719616,148369.695549906,838579.773024385,137.53254699707,130,2.13840548586505,0.071882966157493 +-151.4544,57.5249434,13.719616,152074.082701018,838579.785176758,107.507881164551,130,2.03144030258479,-0.316645110419325 +-151.39247,57.5236568,13.719616,155777.540154426,838579.763381137,82.3089599609375,31,1.91544711406754,-0.737965478866132 +-151.33053,57.5223393,13.719616,159481.865646115,838579.776970772,80.3571624755859,31,1.90502459279806,-0.77582305100064 +-151.2686,57.5209909,13.719616,163185.871375187,838579.779126571,76.5439147949219,31,1.8839106702004,-0.852514844388823 +-151.20668,57.5196116,13.719616,166889.563753904,838579.768842401,77.9919662475586,31,1.89204986943349,-0.822950949615497 +-151.14476,57.5182014,13.719616,170593.546300517,838579.770814874,77.0218048095703,31,1.88661369098957,-0.842696701363632 +-151.08284,57.5167602,13.719616,174297.825915268,838579.774585705,79.8668975830078,31,1.90236681465973,-0.785476859804453 +-151.02093,57.5152882,13.719616,178001.810929396,838579.77637658,83.3566131591797,31,1.92094006060803,-0.718013529188022 +-150.95903,57.5137853,13.719616,181705.508230269,838579.764085925,85.8296966552734,31,1.93363757761669,-0.6718925231804 +-150.89713,57.5122515,13.719616,185409.521331201,838579.764702086,87.7743225097656,31,1.94336748602795,-0.636550718638352 +-150.83523,57.5106868,13.719616,189113.856637042,838579.778983319,90.5363311767578,31,1.95682289150701,-0.587676845383339 +-150.77334,57.5090912,13.719616,192817.923444168,838579.778669052,97.1021499633789,31,1.98722884583895,-0.477233740526315 +-150.71146,57.5074648,13.719616,196521.727602036,838579.774027409,101.989158630371,31,2.00855400904384,-0.399774660958592 +-150.64958,57.5058075,13.719616,200225.873150525,838579.78318456,106.070762634277,134,2.02559569138083,-0.337874406530227 +-150.58771,57.5041193,13.719616,203929.769381874,838579.776252155,109.948760986328,134,2.04119033965558,-0.281230192840553 +-150.52584,57.5024002,13.719616,207634.019801195,838579.78365597,116.571220397949,134,2.066591343175,-0.188966497889826 +-150.46398,57.5006503,13.719616,211338.033103568,838579.785572985,162.250793457031,134,2.21018682931319,0.332613293996365 +-150.40213,57.4988696,13.719616,215041.815652857,838579.781192542,217.369567871094,134,2.3371987420006,0.793956813686155 +-150.34028,57.4970579,13.719616,218745.972148641,838579.780358462,313.620666503906,231,2.49640467344122,1.37223819857546 +-150.27844,57.4952155,13.719616,222449.910030648,838579.783917424,421.051971435547,330,2.62433570513407,1.83692022083572 +-150.21661,57.4933422,13.719616,226153.636898591,838579.768805832,422.020416259766,330,2.62533346151731,1.84054435680769 +-150.15478,57.491438,13.719616,229857.756248454,838579.768886489,528.85546875,330,2.72333699963318,2.19652118023922 +-150.09296,57.4895031,13.719616,233561.676047205,838579.772223881,652.811889648438,330,2.81478805561358,2.52869751829018 +-135.5078,56.1274155,13.719616,1133633.73667925,838579.756548746,494.371795654297,351,2.69405368590538,2.09015582649 +-135.45047,56.1182704,13.719616,1137337.63847146,838579.736340175,351.031860351562,351,2.54534653568785,1.55000901165346 +-135.39316,56.1090975,13.719616,1141042.04454316,838579.84554332,313.280822753906,350,2.49593381069063,1.37052789066769 +-135.33589,56.099897,13.719616,1144745.75896475,838579.761281135,322.640960693359,350,2.50871950215355,1.41696917146071 +-135.27864,56.0906689,13.719616,1148449.98035893,838579.826505065,336.338958740234,350,2.52677717533116,1.48255979461483 +-135.22143,56.0814132,13.719616,1152153.51891413,838579.694683935,347.218658447266,350,2.54060305476183,1.53277933500593 +-135.16424,56.0721299,13.719616,1155857.57324173,838579.711017139,378.346038818359,350,2.57788919138054,1.66821322572802 +-135.10708,56.062819,13.719616,1159561.55062598,838579.70136329,391.496704101562,350,2.5927281102087,1.722112414361 +-135.04994,56.0534806,13.719616,1163266.04942157,838579.850379129,415.439666748047,350,2.61850796121048,1.81575219150151 +-134.99284,56.0441147,13.719616,1166969.87976673,838579.807096964,400.899047851562,350,2.60303502478805,1.75955006999952 +-134.93577,56.0347212,13.719616,1170673.64627198,838579.734234287,374.621551513672,350,2.57359275818132,1.65260735402434 +-134.87872,56.0253002,13.719616,1174377.94724745,838579.81813772,316.607055664062,350,2.50052058899072,1.38718837865051 +-134.82171,56.0158518,13.719616,1178081.58963954,838579.715204514,329.320526123047,350,2.51761880056966,1.44929396342067 +-134.76472,56.0063759,13.719616,1181785.77514884,838579.767800426,341.775817871094,350,2.53374133124407,1.50785559665854 +-134.70776,55.9968726,13.719616,1185489.90779923,838579.808610449,347.889007568359,350,2.5414407063336,1.53582192460416 +-134.65083,55.9873419,13.719616,1189193.99188171,838579.836473182,296.584106445312,251,2.47214787404218,1.28413057957831 +-134.59393,55.9777838,13.719616,1192898.03168157,838579.850235388,233.574020385742,151,2.3684245360835,0.907377810524216 +-134.53706,55.9681983,13.719616,1196602.03147839,838579.848751935,114.833229064941,151,2.06006757718545,-0.212662678032052 +-134.48022,55.9585855,13.719616,1200305.99231657,838579.841554954,88.0580444335938,50,1.94476903655015,-0.63145988709937 +-134.42341,55.9489453,13.719616,1204009.92167553,838579.816840587,69.5957107543945,50,1.84258247447982,-1.00263064748745 +-134.36663,55.9392778,13.60067009,1207713.82057002,838579.784151249,82.7311935424805,50,1.91766928983172,-0.729893902218534 +-134.30988,55.929583,11.19651417,1211417.69322948,838579.742365317,27.756103515625,50,1.4433584985106,-2.45272607807507 +-134.25316,55.919861,10.60267639,1215121.54061184,838579.701026625,49.7900886535645,50,1.69714289955764,-1.53090869619242 +-134.19646,55.9101117,7.439751397,1218825.96728984,838579.831893611,11.392201423645,50,1.05660765505017,-3.85751553120425 +-134.08317,55.8905314,13.719616,1226233.58325432,838579.710636283,289.905853271484,251,2.46225698395743,1.24820404364938 +-134.02656,55.8807005,13.719616,1229937.97182417,838579.835144387,259.048797607422,151,2.4133815808205,1.07067462902712 +-133.96999,55.8708424,13.71935676,1233641.7589245,838579.769968405,76.4120483398438,50,1.88316184175588,-0.85523480303623 +-133.85693,55.8510447,9.493800513,1241049.93045884,838579.817710067,16.0030612945557,50,1.20420306866603,-3.32140686102623 +-133.80045,55.8411052,13.719616,1244753.72273661,838579.752811688,227.330139160156,151,2.35665701778932,0.864634825295657 +-133.744,55.8311386,13.719616,1248457.52388281,838579.689235737,90.4122695922852,50,1.9562273713453,-0.589839944589024 +-133.68757,55.821145,13.41297069,1252161.93176067,838579.825103621,96.8998947143555,50,1.98632330517255,-0.480522922693729 +-155.97909,57.5020877,13.719616,-118318.288082677,834875.782030898,33.4574432373047,20,1.52449274982554,-2.1580233192783 +-155.91717,57.5030606,13.719616,-114614.360444027,834875.782798608,32.6565437316895,20,1.51397021843846,-2.19624415670564 +-155.85524,57.5040026,13.719616,-110910.034376549,834875.774217666,35.9837265014648,20,1.55610613719794,-2.04319447298264 +-155.79332,57.5049136,13.719616,-107206.499089616,834875.778618521,33.7526626586914,20,1.52830803886671,-2.14416510048884 +-155.73138,57.5057938,13.719616,-103501.954552464,834875.769446297,51.9840965270996,20,1.71587050042496,-1.46288470445285 +-155.66945,57.506643,13.719616,-99798.1879288822,834875.772368982,47.0862197875977,20,1.67289382547593,-1.61898825463199 +-155.60751,57.5074613,13.719616,-96093.9971633785,834875.767516249,258.872772216797,121,2.41308637450657,1.06960235543465 +-155.54557,57.5082487,13.719616,-92389.9734959288,834875.7700682,296.899597167969,232,2.47260960834765,1.28580773036787 +-155.48363,57.5090051,13.719616,-88686.1107503548,834875.768471452,301.770660400391,232,2.47967701328711,1.31147856234618 +-155.42169,57.5097307,13.719616,-84982.4019910928,834875.784678696,294.390655517578,232,2.46892402060582,1.27242062371804 +-155.35974,57.5104252,13.719616,-81278.2438434148,834875.772600426,278.850708007812,232,2.4453717515118,1.18687205988171 +-155.29779,57.5110889,13.719616,-77574.2268276133,834875.778738656,265.935333251953,232,2.42477604329961,1.11206256905465 +-155.23584,57.5117216,13.719616,-73870.3449623922,834875.780436388,256.178649902344,232,2.40854293252824,1.0530992773419 +-155.17388,57.5123233,13.719616,-70165.9941229517,834875.766814323,245.707336425781,232,2.39041812400823,0.987264799461834 +-155.11193,57.5128942,13.719616,-66462.3628047302,834875.781592414,236.819808959961,232,2.37441802643853,0.929147878206157 +-155.04997,57.5134341,13.719616,-62758.249632568,834875.781585237,234.402359008789,232,2.36996197807705,0.912962238674424 +-154.98801,57.513943,13.719616,-59054.2458099307,834875.777090375,227.221557617188,232,2.35644953262898,0.863881179971134 +-154.92605,57.514421,13.719616,-55350.3447192413,834875.779020764,229.636306762695,232,2.36104055350006,0.880557078182717 +-154.86408,57.514868,13.719616,-51645.9424098412,834875.768197368,242.223587036133,232,2.38421643121359,0.964738481092357 +-154.80212,57.5152841,13.719616,-47942.2276139452,834875.771675322,195.887619018555,121,2.2920069874912,0.629807462297075 +-154.74015,57.5156693,13.719616,-44237.9985699518,834875.774252817,187.137420654297,121,2.2721606392301,0.557719860701022 +-154.67819,57.5160235,13.719616,-40534.4442895111,834875.77845342,111.391761779785,121,2.04685307283161,-0.260661529640255 +-154.61622,57.5163468,9.00989897,-36830.3628754883,834875.782502608,17.9012432098389,35,1.25288319301477,-3.1445867547008 +-152.94301,57.5133745,5.93124437,63177.9159536292,834875.783248295,28.7944488525391,30,1.45930877022166,-2.3947901385597 +-152.2616,57.5056956,13.59940142,103921.801729964,834875.77065767,26.8222751617432,31,1.42849561349629,-2.50671231873676 +-152.19967,57.504812,13.719616,107625.769094775,834875.775976823,41.5090942382812,31,1.61814325682809,-1.81785794732907 +-152.13774,57.5038974,13.719616,111329.923870843,834875.77773419,64.601936340332,31,1.81024553547679,-1.12008763982775 +-152.07582,57.5029519,13.719616,115033.674523625,834875.770223436,60.6247444152832,31,1.78264992069459,-1.22032278928934 +-152.0139,57.5019755,13.719616,118737.625139814,834875.770118348,48.3106269836426,31,1.68404267387172,-1.57849245506033 +-151.95198,57.5009682,13.719616,122441.7821404,834875.777901941,100.68782043457,31,2.00297693988862,-0.420032167984349 +-151.89007,57.4999299,13.719616,126145.554635327,834875.763917111,93.1797637939453,31,1.96932160519874,-0.542277949766896 +-151.82816,57.4988608,13.719616,129849.546009741,834875.768878385,90.7047882080078,31,1.95763021360285,-0.584744421098566 +-151.76625,57.4977607,13.719616,133553.763401801,834875.770993454,87.6220703125,31,1.94261351036547,-0.639289373450581 +-151.70435,57.4966298,13.719616,137257.614823423,834875.772458814,110.303230285645,130,2.04258823115903,-0.276152651902083 +-151.64245,57.4954679,13.719616,140961.705117383,834875.771066507,135.683135986328,130,2.13252587269137,0.0505265329020142 +-151.58055,57.4942752,13.719616,144666.039916939,834875.789709913,153.403823852539,130,2.18583618528023,0.244164804502883 +-151.51866,57.4930515,13.719616,148370.028774698,834875.784319442,159.107879638672,130,2.20169168812462,0.301756516444761 +-151.45678,57.491797,13.719616,152073.677280272,834875.77614417,159.262741088867,130,2.20211418614551,0.303291149849581 +-151.3949,57.4905115,13.719616,155777.590355548,834875.765271026,109.455253601074,130,2.03923661154305,-0.288326690994791 +-151.33302,57.4891952,13.719616,159481.773546398,834875.774651112,81.6749801635742,31,1.91208903767026,-0.750162970831471 +-151.27115,57.487848,13.719616,163185.636025613,834875.769204751,77.3673858642578,31,1.88855792290248,-0.835634696116897 +-151.20928,57.4864699,13.719616,166889.781867114,834875.773054247,76.5068359375,31,1.88370024139281,-0.853279181880349 +-151.14742,57.485061,13.719616,170593.619334397,834875.772348862,84.2320404052734,31,1.92547732100518,-0.701532904362527 +-151.08556,57.4836211,13.719616,174297.753447593,834875.770044459,85.3736801147461,31,1.93132400250729,-0.680296088337817 +-151.02371,57.4821504,13.719616,178001.591977911,834875.762360588,84.7621536254883,31,1.92820198267518,-0.69163615548122 +-150.96186,57.4806489,13.719616,181705.738963287,834875.775709751,89.5707702636719,31,1.95216630894511,-0.604590882369144 +-150.90002,57.4791165,13.719616,185409.603631634,834875.771759539,88.2060852050781,31,1.9454985474881,-0.628810095149583 +-150.83818,57.4775532,13.719616,189113.790049487,834875.778069647,91.6850357055664,31,1.96229845845272,-0.567788023354097 +-150.77635,57.475959,13.719616,192817.706952264,834875.766377947,99.4617691040039,31,1.99765617966268,-0.439358687821132 +-150.71452,57.4743341,13.719616,196521.95729946,834875.787694771,99.6056442260742,31,1.9982839487328,-0.437078451375347 +-150.6527,57.4726782,13.719616,200225.951449169,834875.779213859,101.363296508789,134,2.00588072610878,-0.409484787609657 +-150.59089,57.4709916,13.719616,203929.694109896,834875.773534867,112.98819732666,134,2.05303307973462,-0.238213980618955 +-150.52908,57.4692741,13.719616,207633.790445658,834875.778776944,145.014450073242,134,2.16141127998942,0.155446576924584 +-150.46728,57.4675257,13.719616,211337.649184872,834875.763964799,191.33154296875,134,2.28178657383286,0.592684002693498 +-150.40548,57.4657466,13.719616,215041.873176113,834875.782967433,267.061676025391,231,2.42661157021958,1.11872972673951 +-150.34369,57.4639366,13.719616,218745.872311456,834875.781422638,363.039733886719,231,2.55995416019695,1.60306807330167 +-150.28191,57.4620958,13.719616,222449.652354878,834875.769698322,400.029571533203,330,2.60209209702544,1.75612508722732 +-150.22013,57.4602242,13.719616,226153.817327388,834875.781080793,483.931823730469,330,2.68478418258825,2.05648634466251 +-150.15836,57.4583217,13.719616,229857.776564191,834875.770732363,603.027160644531,330,2.78033687342108,2.40356099122061 +-135.52418,56.0954724,13.719616,1133633.71856676,834875.75840989,515.708129882812,450,2.71240397789772,2.15680932470097 +-135.46689,56.0863347,13.719616,1137337.94693725,834875.817647821,507.469543457031,351,2.70540998253508,2.13140513725881 +-135.40963,56.0771694,13.719616,1141042.07254891,834875.853329864,368.316497802734,350,2.56622117240968,1.62583165044168 +-135.35241,56.0679765,13.719616,1144745.50215061,834875.691831466,331.791320800781,350,2.52086502129766,1.46108516366841 +-135.2952,56.058756,13.719616,1148450.0331452,834875.849027718,350.252410888672,350,2.54438113334266,1.54650239478248 +-135.23803,56.0495078,13.719616,1152153.88004837,834875.795859065,372.192993164062,350,2.57076819292471,1.64234772680114 +-135.18089,56.0402322,13.719616,1155857.6355983,834875.735591701,390.546813964844,350,2.59167309923263,1.7182803133658 +-135.12377,56.0309289,13.719616,1159561.91117466,834875.809492003,398.663391113281,350,2.6006063566369,1.75072845406362 +-135.06669,56.0215981,13.719616,1163265.50958995,834875.689105605,397.295257568359,350,2.59911338100254,1.74530554042197 +-135.00963,56.0122398,13.719616,1166969.63052633,834875.722988328,392.068969726562,350,2.59336247145144,1.72441659545936 +-134.9526,56.0028541,13.719616,1170673.67751194,834875.746027909,380.485076904297,350,2.58033762787345,1.6771066459236 +-134.8956,55.9934408,13.719616,1174377.661186,834875.735643955,338.396118164062,350,2.52942537248283,1.49217880254045 +-134.83863,55.9840001,13.719616,1178081.57956742,834875.712034095,296.067749023438,251,2.47139110180336,1.2813817668026 +-134.78168,55.974532,13.719616,1181786.03462333,834875.851963841,293.036224365234,151,2.46692131001116,1.26514620720772 +-134.72477,55.9650364,13.719616,1185489.83851075,834875.788233066,231.678894042969,151,2.36488647134638,0.894526549534784 +-134.66789,55.9555135,13.719616,1189193.58681425,834875.718430898,144.955642700195,151,2.161235125837,0.154806734763599 +-134.61103,55.9459631,13.719616,1192897.88787338,834875.799661339,99.2973480224609,50,1.99693764975831,-0.441968593522672 +-134.55421,55.9363855,13.719616,1196601.54101274,834875.704109282,83.3461303710938,50,1.92088544102673,-0.718211923097289 +-134.49741,55.9267805,13.719616,1200305.7522345,834875.769078915,73.2509536743164,50,1.86481328326228,-0.921882004684984 +-134.44064,55.9171481,13.719616,1204009.92814187,834875.813810995,78.7831192016602,50,1.89643317151313,-0.807029545343269 +-134.3839,55.9074885,12.3992998,1207714.06650776,834875.858505191,87.3149185180664,50,1.94108845305887,-0.644828816882817 +-134.15725,55.8685775,13.6385654,1222529.75053635,834875.766278752,86.5659484863281,151,1.93734709187092,-0.658418508608262 +-134.10066,55.8587817,13.719616,1226233.77074849,834875.772044106,209.950088500977,251,2.32211606204363,0.739172215056999 +-134.0441,55.8489587,13.719616,1229937.77858309,834875.771078002,318.163543701172,251,2.50265041517083,1.39492451524956 +-133.98757,55.8391086,13.719616,1233641.77490008,834875.772933522,200.342025756836,151,2.30177206082549,0.665276995876668 +-133.93107,55.8292313,13.71584367,1237345.76715159,834875.765879144,23.0225086212158,50,1.36215264427171,-2.74768891912911 +-133.8746,55.8193269,13.719616,1241049.75616806,834875.759477507,142.500991821289,151,2.15381788708849,0.127865206538292 +-133.81816,55.8093955,13.719616,1244753.74273815,834875.763287066,249.505142211914,251,2.39707950070588,1.01146082097392 +-133.76175,55.7994369,13.719616,1248457.7376408,834875.754967914,128.370742797852,50,2.10846605419008,-0.0368655952505886 +-133.48015,55.7492388,9.482634242,1266977.88353347,834875.802773054,46.1308135986328,50,1.66399111422849,-1.65132544296949 +-133.42392,55.7391183,8.995748244,1270681.97071971,834875.837747935,38.6429176330566,50,1.58706990925744,-1.93072521492207 +-133.36773,55.7289708,8.749743419,1274385.4903798,834875.682639583,15.5313034057617,50,1.19120790377602,-3.3686090090961 +-155.97724,57.4689309,13.719616,-118317.933124079,831171.771014469,34.5354156494141,20,1.53826468730498,-2.10799971145067 +-155.91538,57.4699029,13.719616,-114614.147315466,831171.773526187,50.925853729248,20,1.70693831831616,-1.49532893937059 +-155.85351,57.4708441,13.719616,-110909.961919516,831171.774469728,65.7441787719727,20,1.81785730485561,-1.09243952082859 +-155.79164,57.4717543,13.719616,-107205.969373819,831171.768872912,78.199089050293,20,1.89320169394559,-0.818767194224117 +-155.72977,57.4726337,13.719616,-103502.162646146,831171.778609588,75.1588363647461,121,1.87598004758227,-0.881321129362935 +-155.66789,57.4734821,13.719616,-99797.9376856734,831171.765893502,230.767272949219,121,2.36317421789201,0.88830715626273 +-155.60602,57.4742997,13.719616,-96094.483945517,831171.783242538,294.371856689453,220,2.46889628708965,1.27231988767141 +-155.54413,57.4750864,13.719616,-92390.0006269402,831171.775681424,306.477935791016,220,2.48639921389805,1.33589551367218 +-155.48225,57.4758421,13.719616,-88686.2762246926,831171.775066769,302.250457763672,220,2.48036696727999,1.3139846721808 +-155.42036,57.476567,13.719616,-84982.1073617136,831171.776085333,285.948272705078,220,2.45628747749777,1.22652109232111 +-155.35847,57.4772609,13.719616,-81278.0863249907,831171.76996372,270.757293701172,220,2.43258016454577,1.14040936493864 +-155.29658,57.477924,13.719616,-77574.2062230889,831171.778686148,262.095794677734,220,2.41846005275543,1.08912108863498 +-155.23469,57.4785561,13.719616,-73870.4610775648,831171.779596985,250.730484008789,220,2.39920713903187,1.01918901066233 +-155.17279,57.4791573,13.719616,-70166.2460120105,831171.772981962,241.612442016602,220,2.38311929484985,0.960753368665348 +-155.11089,57.4797276,13.719616,-66462.1528231437,831171.770224715,238.363174438477,220,2.37723916057526,0.939395042622615 +-155.04899,57.480267,13.719616,-62758.1750845494,831171.771043191,232.26513671875,220,2.36598402655896,0.898513183340352 +-154.98709,57.4807755,13.719616,-59054.3063693369,831171.7751706,229.799270629883,220,2.3613486459279,0.881676157818962 +-154.92518,57.4812531,13.719616,-55349.9420275358,831171.774020981,232.7138671875,220,2.36682226323332,0.901557898198177 +-154.86328,57.4816997,13.719616,-51646.272221786,831171.773419574,212.841018676758,220,2.32805532883113,0.76074532726471 +-154.80137,57.4821155,13.719616,-47942.0937779691,831171.779364532,187.568222045898,121,2.27315926176621,0.561347142787428 +-154.73946,57.4825003,13.719616,-44237.99877007,831171.777654105,125.418739318848,121,2.09836243103015,-0.0735648384286112 +-154.67755,57.4828541,13.1552428,-40533.9807379816,831171.768097583,40.4314155578613,35,1.60671894682974,-1.85935430206581 +-152.8202,57.4790908,11.39287177,70585.7315917315,831171.777180115,70.8846664428711,30,1.85055230007087,-0.97368196612605 +-152.7583,57.4784861,13.71467285,74289.9608625337,831171.784176468,58.476375579834,30,1.76698044680791,-1.2772387909589 +-152.26322,57.4725356,13.719616,103921.802565807,831171.775711552,36.6458396911621,31,1.56402467742931,-2.01443207468588 +-152.20135,57.4716527,13.719616,107625.630058229,831171.766540946,54.9253921508789,31,1.73977316633638,-1.37606339936248 +-152.13948,57.470739,13.719616,111329.644094654,831171.772753986,44.0502662658691,31,1.64394853788877,-1.72412580095616 +-152.07761,57.4697943,13.719616,115033.851709582,831171.772478631,38.8460083007812,31,1.58934639863219,-1.92245635573825 +-152.01575,57.4688188,13.719616,118737.660462973,831171.770625514,66.3441619873047,31,1.82180271275812,-1.07810867319514 +-151.95389,57.4678124,13.719616,122441.675307958,831171.773278767,74.5734939575195,31,1.87258449136641,-0.893654758727186 +-151.89203,57.4667751,13.719616,126145.902661409,831171.780935624,73.1999969482422,31,1.86451106295236,-0.922979755112895 +-151.83018,57.4657069,13.719616,129849.750716695,831171.774556141,72.5537414550781,31,1.86065981307145,-0.936968593936516 +-151.76833,57.4646078,13.719616,133553.824111543,831171.773104993,70.5851058959961,31,1.84871307060446,-0.980362572516409 +-151.70649,57.4634779,13.719616,137257.53065194,831171.767616485,68.2086486816406,31,1.83383944557396,-1.03438782398245 +-151.64464,57.4623171,13.719616,140962.073561122,831171.788266763,78.4313430786133,31,1.89448965204485,-0.814088962787742 +-151.58281,57.4611254,13.719616,144665.664583433,831171.771952145,118.399200439453,130,2.07334876956675,-0.164421596473467 +-151.52098,57.4599028,13.719616,148369.506575352,831171.760596976,149.740036010742,130,2.17533793323482,0.206032156574476 +-151.45915,57.4586494,13.719616,152073.605519977,831171.765962671,169.774993896484,130,2.22987372352563,0.404121712974976 +-151.39732,57.4573651,13.719616,155777.968232758,831171.777509522,176.699111938477,130,2.24723436681753,0.467180524632074 +-151.3355,57.45605,13.719616,159482.002451244,831171.783014132,99.2812271118164,130,1.99686713638549,-0.442224718219285 +-151.27369,57.454704,13.719616,163185.715009469,831171.770294679,94.063591003418,31,1.97342155449936,-0.527385763665014 +-151.21188,57.4533272,13.719616,166889.710067222,831171.774628156,88.4650802612305,31,1.94677187586635,-0.624185003035676 +-151.15007,57.4519195,13.719616,170593.994477008,831171.785537126,85.8566207885742,31,1.93377379118097,-0.67139775663572 +-151.08827,57.450481,13.719616,174297.975930243,831171.788626026,87.0171051025391,31,1.93960463102627,-0.650218482030199 +-151.02648,57.4490116,13.719616,178001.66129779,831171.771775364,87.9602355957031,31,1.9442863839195,-0.633213019216667 +-150.96469,57.4475114,13.719616,181705.654693108,831171.772551759,93.5515213012695,31,1.97105085423448,-0.535996823692301 +-150.9029,57.4459803,13.719616,185409.96300531,831171.78054012,93.1434707641602,31,1.96915241682238,-0.542892490241009 +-150.84112,57.4444185,13.719616,189113.993348374,831171.790325645,91.325569152832,31,1.96059238747212,-0.57398496011679 +-150.77935,57.4428258,13.719616,192817.753139715,831171.778697016,98.8325271606445,31,1.99489990047359,-0.44937028055633 +-150.71758,57.4412022,13.719616,196521.846997713,831171.774358109,101.504188537598,134,2.0064839636407,-0.407293656712576 +-150.65582,57.4395479,13.719616,200225.68197008,831171.770263045,113.377113342285,134,2.05452539536552,-0.232793464298242 +-150.59406,57.4378627,13.719616,203929.863754983,831171.773956051,142.081115722656,134,2.15253635883916,0.12321033015216 +-150.53231,57.4361468,13.719616,207633.79935584,831171.777303724,175.593948364258,134,2.2445095443873,0.457283191823727 +-150.47057,57.4344,13.719616,211337.496286797,831171.757175373,241.541091918945,231,2.38299102525543,0.960287456886623 +-150.40883,57.4326225,13.719616,215041.557952148,831171.767437542,323.150543212891,231,2.50940489030407,1.41945869685263 +-150.34709,57.4308141,13.719616,218745.991904536,831171.786665047,368.465240478516,330,2.56639652454136,1.6264685794344 +-150.28537,57.428975,13.719616,222449.606835882,831171.771053218,407.348907470703,330,2.6099665558496,1.78472736927101 +-150.22365,57.427105,13.719616,226153.606782472,831171.763970048,501.86083984375,330,2.70058330904472,2.11387328147205 +-150.16193,57.4252043,13.719616,229857.996836917,831171.788630267,632.540832519531,330,2.80108856584079,2.47893706121171 +-135.54053,56.0635257,13.719616,1133633.80773638,831171.783018996,596.708618164062,450,2.7757623103329,2.38694487237405 +-135.48329,56.0543955,13.719616,1137337.75770372,831171.761715982,376.768005371094,351,2.57607401598723,1.66161999059687 +-135.42608,56.0452378,13.719616,1141041.59805271,831171.723868096,618.347534179688,350,2.79123263326653,2.44313750093879 +-135.36889,56.0360524,13.719616,1144745.93756534,831171.819156298,331.395599365234,350,2.52034673708246,1.45920260746575 +-135.31174,56.0268394,13.719616,1148449.58113595,831171.712860772,345.076965332031,350,2.53791597012002,1.52301907661655 +-135.25461,56.0175989,13.719616,1152153.726507,831171.759750185,379.833679199219,350,2.57959347025328,1.67440365304341 +-135.19751,56.0083308,13.719616,1155857.78293921,831171.77550628,390.003662109375,350,2.59106868504298,1.716084908512 +-135.14044,55.9990352,13.719616,1159561.75170016,831171.769605774,387.309661865234,350,2.58805833107443,1.70515044365767 +-135.0834,55.989712,13.719616,1163265.64028026,831171.730125643,380.877746582031,251,2.58078559902231,1.67873380499998 +-135.02638,55.9803614,13.719616,1166970.0449984,831171.852968637,378.277435302734,350,2.57781043588491,1.66792716328882 +-134.9694,55.9709833,13.719616,1170673.77687927,831171.775344923,359.420928955078,251,2.55560336232516,1.58726473358997 +-134.91244,55.9615777,13.719616,1174378.03670901,831171.848051173,343.527282714844,251,2.53596123415244,1.51591891764512 +-134.85552,55.9521447,13.719616,1178081.62920848,831171.727471608,251.312911987305,151,2.40021480240388,1.02284913164523 +-134.79862,55.9426843,13.719616,1181785.75512509,831171.766641842,127.207168579102,151,2.10451158605,-0.0512293522529357 +-134.74175,55.9331965,13.719616,1185489.82053273,831171.787543849,104.148513793945,151,2.01765307691753,-0.366724249308824 +-134.68491,55.9236813,13.719616,1189193.8297222,831171.789002491,129.246002197266,151,2.1114171184931,-0.026146487384385 +-134.6281,55.9141387,13.719616,1192897.78697864,831171.76985076,86.5755081176758,50,1.93739504913348,-0.658244314142264 +-134.57132,55.9045689,13.719616,1196601.69015231,831171.750275393,74.5013046264648,50,1.87216387794445,-0.895182546730755 +-134.51457,55.8949717,13.719616,1200305.54990979,831171.70776846,68.0139465332031,50,1.83259797566761,-1.03889719703309 +-134.45784,55.8853472,13.719616,1204009.96550901,831171.833150803,84.8635101318359,50,1.92872099112798,-0.689750968640902 +-134.40115,55.8756954,13.719616,1207713.74473982,831171.763243561,71.8028030395508,50,1.85614139857166,-0.953380765083659 +-134.34448,55.8660164,10.82623776,1211418.08502604,831171.870723486,23.4247341156006,50,1.36967467009203,-2.72036677434977 +-134.23124,55.8465766,11.04428084,1218826.07919252,831171.864579604,46.0045852661133,50,1.66280111986698,-1.65564784214868 +-134.17467,55.8368159,13.719616,1222529.73820696,831171.758255671,102.460891723633,50,2.01055813124916,-0.392495117075423 +-134.11812,55.827028,13.719616,1226233.97504685,831171.827058014,205.841796875,151,2.31353356434828,0.707998133738766 +-134.06161,55.817213,13.719616,1229937.59414461,831171.71180009,278.23828125,251,2.44441688191731,1.1834037009676 +-134.00512,55.8073709,13.719616,1233641.79608643,831171.781219784,215.516372680664,151,2.33348026890402,0.780450258041502 +-133.94866,55.7975016,13.719616,1237345.990099,831171.838935182,102.038330078125,151,2.00876334249175,-0.399014302126059 +-133.89224,55.7876052,13.719616,1241049.57879314,831171.707628446,194.545303344727,151,2.28902075065716,0.618960597759013 +-133.83584,55.7776818,13.719616,1244753.75940589,831171.770041745,273.588195800781,251,2.43709735544144,1.15681709160638 +-133.77947,55.7677313,13.71435072,1248457.94114673,831171.828142935,106.304344177246,50,2.02655101253512,-0.334404407422059 +-133.72314,55.7577537,13.66957175,1252161.52990538,831171.692317225,17.4585208892822,50,1.24200744688196,-3.18409056890215 +-133.4419,55.7074611,12.93182227,1270682.02422372,831171.845930518,141.115753173828,50,2.1495754980533,0.112455638664116 +-156.1608,57.4326744,13.29267906,-129430.138510938,827467.775617809,19.7134075164795,20,1.29476169975876,-2.99247206489075 +-155.9754,57.435773,13.719616,-118317.970884503,827467.767672802,39.9525909423828,20,1.60154494874371,-1.87814773992037 +-155.9136,57.4367442,13.719616,-114614.333262726,827467.782697293,48.6747360229492,20,1.68730360489495,-1.5666478228216 +-155.85179,57.4376845,13.719616,-110910.295539377,827467.78160625,54.976978302002,20,1.74018086604892,-1.37458251763745 +-155.78998,57.4385939,13.719616,-107206.450079456,827467.781751539,79.5842361450195,121,1.90082705224493,-0.791069716386939 +-155.72816,57.4394725,13.719616,-103502.191395906,827467.778261104,192.592788696289,121,2.28464002168757,0.60304853975694 +-155.66634,57.4403202,13.719616,-99798.1121634735,827467.776240409,282.650909423828,220,2.45125038713247,1.20822494238563 +-155.60452,57.441137,13.719616,-96094.2059644942,827467.775270906,290.9716796875,220,2.46385072110284,1.25399295185937 +-155.5427,57.441923,13.719616,-92390.4661212359,827467.78611206,295.603546142578,220,2.47070963967176,1.27890650183197 +-155.48087,57.442678,13.719616,-88686.2879633607,827467.772696403,287.763397216797,220,2.45903555194348,1.23650288308648 +-155.41904,57.4434023,13.719616,-84982.2631046344,827467.782609627,280.357330322266,220,2.44771191580063,1.19537220452812 +-155.35721,57.4440956,13.719616,-81278.3858715792,827467.782005136,269.962799072266,220,2.43130392241548,1.13577368924568 +-155.29537,57.444758,13.719616,-77574.0508138979,827467.770022589,256.165435791016,220,2.40852053033489,1.05301790618143 +-155.23354,57.4453896,13.719616,-73870.4488634006,827467.781418253,243.603591918945,220,2.38668368765163,0.9737002607004 +-155.1717,57.4459903,13.719616,-70166.3762654195,827467.781912614,239.49739074707,220,2.37930078626698,0.946883455581512 +-155.10986,57.4465601,13.719616,-66462.4253776986,827467.782889884,235.924255371094,220,2.37277259299371,0.923171194281129 +-155.04801,57.447099,13.719616,-62757.9909967393,827467.774618641,233.667999267578,220,2.3685992400212,0.908012385091426 +-154.98617,57.447607,13.719616,-59054.2642596692,827467.776290318,232.759094238281,220,2.36690665850556,0.901864445915746 +-154.92432,57.4480841,13.719616,-55350.0411817009,827467.769311762,228.299560546875,220,2.35850507551892,0.87134749845776 +-154.86247,57.4485304,13.719616,-51645.9139737221,827467.7740621,209.098815917969,121,2.32035157350754,0.732763089058753 +-154.80063,57.4489457,13.719616,-47942.4752916347,827467.775210246,150.477722167969,121,2.17747220853003,0.213784453629513 +-154.73877,57.4493302,13.69697948,-44237.9220894785,827467.773223874,58.8180389404297,35,1.76951054054596,-1.26804876834164 +-153.00683,57.447551,3.22939564,59473.5036957897,827467.770790229,15.0608139038086,30,1.17784844227515,-3.4171343864372 +-152.69762,57.4446845,13.55186831,77993.9563529724,827467.775213247,92.7919616699219,30,1.9675103560292,-0.548856923732655 +-152.63579,57.4440186,13.71787557,81697.7082760245,827467.775342985,87.8055877685547,30,1.94352215440077,-0.635988918961538 +-152.57396,57.4433218,10.23413572,85401.601882143,827467.775813615,15.4784965515137,30,1.18972877475186,-3.37398162789731 +-152.26484,57.4393745,13.719616,103921.622943761,827467.771236908,37.8541259765625,31,1.57811322310148,-1.96325845553328 +-152.20302,57.4384924,13.719616,107625.902361614,827467.774794626,40.2277450561523,31,1.6045256891182,-1.86732084009221 +-152.14121,57.4375795,13.719616,111329.769281452,827467.774703503,45.0531997680664,31,1.65372564087037,-1.68861257226397 +-152.0794,57.4366357,13.719616,115033.829191417,827467.775900539,49.117488861084,31,1.69123615533075,-1.55236367717712 +-152.01759,57.4356611,13.719616,118738.088173533,827467.790012314,67.9648818969727,31,1.83228456655911,-1.04003558837101 +-151.95579,57.4346555,13.719616,122441.95451801,827467.776761186,71.3000030517578,31,1.85308954844039,-0.964465955845183 +-151.89399,57.4336192,13.719616,126146.032387911,827467.787446039,67.870246887207,31,1.83167942899929,-1.04223362071176 +-151.8322,57.4325519,13.719616,129849.730446515,827467.769544709,69.3670959472656,31,1.84115351314624,-1.00782104291717 +-151.77041,57.4314539,13.719616,133553.65279281,827467.775499892,69.2554550170898,31,1.84045398698581,-1.01036192159649 +-151.70862,57.4303249,13.719616,137257.806930925,827467.772374259,63.3903503417969,31,1.80202315201001,-1.14995368348101 +-151.64684,57.4291652,13.719616,140961.599334938,827467.772976056,65.1093673706055,31,1.81364347558357,-1.10774535149125 +-151.58506,57.4279746,13.719616,144665.635943778,827467.775668857,64.4309158325195,31,1.80909430452938,-1.12426923922278 +-151.52328,57.4267531,13.719616,148369.923165419,827467.781039929,123.242614746094,130,2.09076090384284,-0.101175754864788 +-151.46151,57.4255008,13.719616,152073.868199752,827467.777950283,158.373199462891,130,2.19968169044698,0.294455631169107 +-151.39974,57.4242177,13.719616,155778.076201896,827467.788799672,202.970260620117,130,2.3074324093677,0.685836997406301 +-151.33798,57.4229037,13.719616,159481.955212604,827467.779048607,182.283401489258,130,2.26074712411401,0.516262716057821 +-151.27623,57.4215589,13.719616,163185.511177749,827467.758827902,93.555793762207,130,1.97107068783862,-0.535924782380978 +-151.21447,57.4201833,13.719616,166889.948029512,827467.777385636,86.585807800293,31,1.93744671304361,-0.658056656074345 +-151.15272,57.4187769,13.719616,170594.074577434,827467.785696695,85.943473815918,31,1.93421290378812,-0.669802774311326 +-151.09098,57.4173397,13.719616,174297.897190611,827467.782779645,89.6551818847656,31,1.95257539594976,-0.603104961603192 +-151.02924,57.4158716,13.719616,178002.021516601,827467.783316958,92.3811798095703,31,1.96558350436554,-0.555855798953282 +-150.96751,57.4143728,13.719616,181705.854153461,827467.782978886,95.947639465332,31,1.98203429455048,-0.496101833478603 +-150.90578,57.4128431,13.719616,185410.001255911,827467.786439667,97.2253952026367,31,1.98777971714709,-0.475232818700815 +-150.84406,57.4112826,13.719616,189113.869908389,827467.777129454,94.9343948364258,134,1.97742358630932,-0.512849241837627 +-150.78234,57.4096914,13.719616,192818.064713291,827467.794328498,105.617958068848,134,2.0237377669396,-0.344622918405216 +-150.72063,57.4080693,13.719616,196521.994322855,827467.786922105,119.147819519043,134,2.07608609888967,-0.154478835061041 +-150.65893,57.4064164,13.719616,200225.66456677,827467.765187112,148.135467529297,134,2.17065905249912,0.189037126256908 +-150.59723,57.4047328,13.719616,203929.680012256,827467.770120472,182.384078979492,134,2.2609869243809,0.517133739072981 +-150.53553,57.4030184,13.719616,207634.047567713,827467.791397645,232.018981933594,231,2.36552351683826,0.896840480592193 +-150.47385,57.4012732,13.719616,211337.576028243,827467.766215507,299.938049316406,231,2.47703156265842,1.30186953057599 +-150.41216,57.3994972,13.719616,215042.068089318,827467.789226155,392.579315185547,330,2.59392741310037,1.72646862477868 +-150.35049,57.3976905,13.719616,218745.733149445,827467.775308987,423.051300048828,330,2.62639303398794,1.84439302645309 +-150.28882,57.395853,13.719616,222449.775713274,827467.77784703,426.719085693359,330,2.63014206780879,1.8580105873712 +-150.22716,57.3939847,13.719616,226153.603350241,827467.763688824,532.775573730469,330,2.72654430543168,2.2081710303556 +-150.1655,57.3920857,13.719616,229857.820544647,827467.777836308,689.606018066406,430,2.83860104284222,2.61519308480782 +-135.49966,56.0224528,13.719616,1137337.67237294,827467.741196672,524.001708984375,450,2.71933270339837,2.18197643337447 +-135.44249,56.0133025,13.719616,1141041.82758475,827467.780753592,327.017486572266,350,2.51457097626516,1.43822339561106 +-135.38535,56.0041247,13.719616,1144745.87380453,827467.799907664,345.745513916016,350,2.53875655380186,1.52607231647545 +-135.32824,55.9949193,13.719616,1148449.8185055,827467.786683731,296.00341796875,350,2.47129672591163,1.28103896662628 +-135.27116,55.9856863,13.719616,1152153.66608969,827467.739833496,297.944549560547,251,2.47413544508073,1.29135000489955 +-135.2141,55.9764258,13.719616,1155858.01662245,827467.842867567,229.080703735352,251,2.35998850859491,0.876735750803697 +-135.15708,55.9671378,13.719616,1159561.67690633,827467.74701191,227.334197998047,151,2.35666477177728,0.86466298999315 +-135.10008,55.9578222,13.719616,1163265.85198944,827467.788986097,199.889434814453,151,2.30078984002586,0.661709289578683 +-135.04311,55.9484792,13.719616,1166969.94119312,827467.814921554,264.994750976562,251,2.42323727150476,1.10647331068656 +-134.98617,55.9391088,13.719616,1170673.94883634,827467.823595161,233.414398193359,251,2.36812764203952,0.906299406614498 +-134.92926,55.9297109,13.719616,1174377.88238954,827467.803101739,201.61799621582,151,2.30452929418424,0.67529205442837 +-134.87238,55.9202856,13.719616,1178081.74302156,827467.762930694,165.935272216797,151,2.21993871212987,0.368034915851003 +-134.81553,55.9108329,13.719616,1181785.53503442,827467.701883691,111.696090698242,151,2.04803797331353,-0.256357632885654 +-134.7587,55.9013528,13.719616,1185489.8615049,827467.797278423,130.917739868164,151,2.11699849914699,-0.00587331976484366 +-134.70191,55.8918453,13.719616,1189193.52916296,827467.691474893,130.857482910156,151,2.11679856223513,-0.00659954769637901 +-134.64514,55.8823106,13.719616,1192897.73344913,827467.762224866,124.561874389648,50,2.0953851348118,-0.0843792280985956 +-134.5884,55.8727485,13.719616,1196601.88623129,827467.808491121,60.3092956542969,50,1.78038425642256,-1.22855232861031 +-134.53169,55.8631591,13.719616,1200305.98856237,827467.839786271,86.8026962280273,50,1.93853321525447,-0.654110169925904 +-134.47501,55.8535424,13.719616,1204010.04468313,827467.854952034,95.2280349731445,151,1.97876482277258,-0.507977488176086 +-134.41836,55.8438984,13.719616,1207714.05882863,827467.852838122,82.1253890991211,50,1.91447744020194,-0.741487611118458 +-134.36174,55.8342272,13.08364428,1211418.03198032,827467.842963858,57.5872650146484,50,1.76032645312182,-1.30140799526564 +-134.30515,55.8245288,10.32259565,1215121.96833472,827467.824186147,46.6393699645996,50,1.668752675054,-1.63403009496645 +-134.24859,55.8148032,13.69297582,1218825.87208272,827467.795369769,85.0110931396484,50,1.92947560071419,-0.687010011236764 +-134.19206,55.8050505,13.719616,1222529.74413441,827467.766040273,86.8207550048828,50,1.93862355820193,-0.653782018554274 +-134.13556,55.7952705,13.719616,1226233.59521036,827467.713769406,186.127532958984,151,2.26981062099596,0.549183923712631 +-134.07908,55.7854634,13.719616,1229938.02170559,827467.843949032,268.711486816406,151,2.42928623194992,1.12844486156857 +-134.02264,55.7756292,13.719616,1233641.83020037,827467.785622572,127.42308807373,251,2.10524812591577,-0.048554029231033 +-133.96623,55.7657679,13.719616,1237345.62361039,827467.722327995,245.560165405273,251,2.39015791724195,0.986319654216305 +-133.90984,55.7558795,13.719616,1241050.00484564,827467.839841865,88.614631652832,50,1.94750543657608,-0.621520501158863 +-133.85349,55.7459641,13.719616,1244753.77714023,827467.774519449,216.738555908203,151,2.33593617541178,0.789370811463192 +-133.79717,55.7360216,13.719616,1248457.54670381,827467.700953734,144.720809936523,151,2.16053098440716,0.152249092108471 +-133.74087,55.7260521,13.719616,1252161.91308222,827467.817246643,44.2624397277832,50,1.64603534838726,-1.71654590959065 +-133.68461,55.7160556,13.70824572,1255865.68279454,827467.74578566,27.3039741516113,50,1.4362258641287,-2.47863384200664 +-133.62837,55.7060321,12.55223293,1259570.05747563,827467.863154514,72.1626815795898,50,1.85831266330301,-0.945494111838726 +-133.57217,55.6959816,8.969402681,1263273.84363314,827467.78952471,150.102447509766,50,2.17638777373108,0.209845476911191 +-133.516,55.6859042,12.19352607,1266977.64072729,827467.723565069,71.3510360717773,50,1.85340028378548,-0.963337276379113 +-133.45985,55.6757999,12.834362,1270682.05156856,827467.855556452,99.3941116333008,50,1.99736065642032,-0.440432112588143 +-133.40374,55.6656687,8.026466245,1274385.88262062,827467.802337158,13.6724681854248,50,1.13584692148456,-3.56969589837619 +-156.28226,57.3973002,13.20884924,-136838.411450831,823763.781564807,26.7548809051514,20,1.4274030221258,-2.51068092245102 +-156.22053,57.3984246,13.12344652,-133134.441869921,823763.780073488,13.4081335067749,20,1.12736832564233,-3.60049257850736 +-156.15879,57.3995182,13.61080489,-129430.102942967,823763.768871129,28.3880882263184,20,1.45313614628715,-2.41721087053211 +-156.09705,57.400581,13.719616,-125725.987631437,823763.76802458,35.0718994140625,20,1.54495928691681,-2.08368301483151 +-156.03531,57.401613,13.719616,-122022.089557777,823763.777011034,45.5508918762207,20,1.65849688478057,-1.67128205253354 +-155.97357,57.4026141,13.719616,-118318.40267529,823763.784162431,42.0678443908691,20,1.62395025879295,-1.79676525870933 +-155.91182,57.4035844,13.719616,-114614.320914054,823763.78288767,53.0026016235352,20,1.72429718739353,-1.43227657216708 +-155.85007,57.4045238,13.719616,-110910.437543019,823763.779922107,87.7486190795898,20,1.94324029059845,-0.637012728743479 +-155.78831,57.4054324,13.719616,-107206.146511354,823763.769821038,163.093765258789,121,2.21243735916745,0.340787860792182 +-155.72655,57.4063102,13.719616,-103502.040775413,823763.769395657,275.717254638672,220,2.44046394550323,1.16904550763128 +-155.66479,57.4071572,13.719616,-99798.1139526775,823763.778213963,281.840637207031,220,2.45000361206073,1.20369629946002 +-155.60303,57.4079733,13.719616,-96094.359929379,823763.784696952,289.786468505859,220,2.46207810235517,1.24755429461209 +-155.54126,57.4087585,13.719616,-92390.1729523144,823763.774530281,291.028656005859,220,2.46393575370239,1.25430181453165 +-155.47949,57.4095129,13.719616,-88686.1456950801,823763.773516639,287.370178222656,220,2.45844169732175,1.23434583359737 +-155.41772,57.4102365,13.719616,-84982.2717723772,823763.781284658,274.25732421875,220,2.4381582345159,1.16067050720983 +-155.35594,57.4109292,13.719616,-81277.9456881256,823763.774076377,260.489654541016,220,2.41579047978538,1.07942443763576 +-155.29417,57.411591,13.719616,-77574.3597008538,823763.776585111,252.57878112793,220,2.40239686313886,1.03077499905682 +-155.23239,57.412222,13.719616,-73870.3085089015,823763.775728327,243.252365112305,220,2.38605707155182,0.97142421217184 +-155.17061,57.4128222,13.719616,-70166.3850627114,823763.783433972,239.766510009766,220,2.37978852182504,0.948655050341972 +-155.10882,57.4133914,13.719616,-66461.9840088212,823763.767071029,234.118865966797,220,2.36943641179634,0.911053231931353 +-155.04704,57.4139299,13.719616,-62758.2970443606,823763.78042341,231.322280883789,220,2.36421746588281,0.89209653073794 +-154.98525,57.4144374,13.719616,-59054.1196320362,823763.770276122,245.115386962891,220,2.38937057466835,0.983459801259039 +-154.92346,57.4149141,13.719616,-55350.0443475259,823763.768714709,221.871810913086,220,2.34610212808795,0.826296453234808 +-154.86167,57.41536,13.719616,-51646.0648008042,823763.775504383,176.765640258789,121,2.24739785063063,0.467774344504187 +-154.79988,57.415775,13.719616,-47942.1747359312,823763.779260879,104.49836730957,35,2.0191095050501,-0.361434086625331 +-154.73809,57.4161591,12.92466314,-44238.3677309579,823763.779779407,28.8316612243652,35,1.45986966631433,-2.39275280385543 +-153.8729,57.4182955,9.493234212,7617.59663933307,823763.774336717,32.9484901428223,35,1.51783551793869,-2.1822042856545 +-152.63706,57.4108522,10.12851326,81697.658340382,823763.767656649,81.0627975463867,30,1.90882158753784,-0.762031282335532 +-152.57528,57.410156,13.69531022,85402.0007822469,823763.77479032,86.2963180541992,30,1.93599226636577,-0.663339621548649 +-152.51351,57.409429,13.55037339,89105.8915395489,823763.778086764,42.2708320617676,30,1.62604079659357,-1.78917182871858 +-152.45174,57.4086711,13.50331656,92809.9365965337,823763.779043397,33.1134033203125,31,1.52000381884552,-2.17432839786617 +-152.38998,57.4078824,13.719616,96513.5427608064,823763.774663353,28.8702735900879,31,1.46045089950602,-2.39064159900272 +-152.32821,57.4070628,13.55489207,100217.915374189,823763.782680865,16.5602054595947,31,1.21906572069854,-3.26742146662091 +-152.26645,57.4062123,13.61745021,103921.862175491,823763.773876823,28.7327556610107,31,1.45837727969818,-2.39817357801481 +-152.20469,57.4053311,13.719616,107625.988313526,823763.785525994,42.0999984741211,31,1.62428208009503,-1.79555998902895 +-152.14294,57.4044189,13.719616,111329.701738016,823763.767814488,47.1184234619141,31,1.67319075093767,-1.61790973660399 +-152.08119,57.403476,13.719616,115033.60726334,823763.770323282,77.3692245483398,31,1.88856824405852,-0.835597206732197 +-152.01944,57.4025022,13.719616,118737.711905103,823763.771194685,75.5508728027344,31,1.87823948589836,-0.873114204490979 +-151.95769,57.4014976,13.719616,122442.02173119,823763.782068824,69.5544738769531,31,1.84232506987924,-1.00356561446735 +-151.89595,57.4004622,13.719616,126145.943782713,823763.784445242,67.1057510375977,31,1.82675974128472,-1.06010333070973 +-151.83421,57.3993959,13.719616,129850.084140182,823763.785553166,69.0780944824219,31,1.83934034905779,-1.01440697241497 +-151.77248,57.3982988,13.719616,133553.84949964,823763.776966966,68.1702194213867,31,1.83359469187647,-1.03527683927138 +-151.71075,57.3971709,13.719616,137257.845575726,823763.778220951,65.8006439208984,31,1.81823014361281,-1.09108526404367 +-151.64902,57.3960122,13.719616,140962.078744025,823763.789869852,64.0104141235352,31,1.8062506369284,-1.13459825161307 +-151.5873,57.3948226,13.719616,144665.956446588,823763.779542173,67.5719757080078,31,1.82976661726065,-1.0491814989173 +-151.52558,57.3936023,13.719616,148370.083594422,823763.79080693,84.9101333618164,31,1.92895952299431,-0.688884552818621 +-151.46387,57.3923511,13.719616,152073.868043465,823763.779049854,157.263305664062,130,2.19662740026686,0.28336157745373 +-151.40216,57.3910691,13.719616,155777.915097812,823763.777827354,169.007690429688,130,2.22790646695206,0.396976075588835 +-151.34046,57.3897564,13.719616,159481.631342814,823763.774911499,173.406097412109,130,2.23906436433901,0.437504743679248 +-151.27876,57.3884128,13.719616,163185.623369587,823763.77153348,99.3730850219727,130,1.99726877263405,-0.440765860726101 +-151.21706,57.3870384,13.719616,166889.897109716,823763.779510287,88.5611114501953,31,1.94724305834106,-0.622473533798684 +-151.15537,57.3856332,13.719616,170593.859592167,823763.773829734,85.9183959960938,31,1.93408616062098,-0.670263141670472 +-151.09369,57.3841973,13.719616,174297.516694371,823763.764663498,93.6133270263672,31,1.97133768038346,-0.534954989250853 +-151.032,57.3827306,13.719616,178002.073924968,823763.793494501,94.8874816894531,31,1.97720892062751,-0.513628968865658 +-150.97033,57.381233,13.719616,181705.740142272,823763.769480639,101.470970153809,31,2.00634181264056,-0.407809989719032 +-150.90866,57.3797047,13.719616,185409.719376692,823763.768155519,103.032699584961,134,2.01297507903079,-0.383716072866976 +-150.84699,57.3781457,13.719616,189114.017958072,823763.79026821,107.688972473145,134,2.03217123310982,-0.313990162124061 +-150.78533,57.3765558,13.719616,192818.043957327,823763.785244816,124.197410583496,134,2.09411254124296,-0.0890016511749966 +-150.72368,57.3749352,13.719616,196521.802662592,823763.774497152,145.563507080078,134,2.1630525105524,0.161407994783195 +-150.66203,57.3732838,13.719616,200225.900298768,823763.776144567,195.321273803711,134,2.29074954790841,0.625240082823424 +-150.60039,57.3716017,13.719616,203929.743311963,823763.771440816,271.492370605469,231,2.43375762968729,1.14468625441468 +-150.53875,57.3698888,13.719616,207633.937944987,823763.779651721,354.359161376953,231,2.5494436652167,1.56489095553944 +-150.47712,57.3681452,13.719616,211337.890620406,823763.780944393,435.350219726562,330,2.6388387679893,1.88959948471219 +-150.4155,57.3663708,13.719616,215041.608260714,823763.763350731,479.445037841797,330,2.68073882812785,2.04179246260324 +-150.35388,57.3645657,13.719616,218745.695941052,823763.770154248,500.808929443359,330,2.69967206375949,2.11056337850082 +-150.29227,57.3627298,13.719616,222449.561263491,823763.757595191,597.015014648438,330,2.77598525356985,2.38775466584498 +-135.516,55.9905065,13.719616,1137337.69850455,823763.74676292,614.49169921875,450,2.78851602065154,2.43326998852268 +-135.45888,55.9813638,13.719616,1141041.55940461,823763.713895603,460.210662841797,351,2.66295667682655,1.97720261354563 +-135.40178,55.9721934,13.719616,1144745.91301813,823763.807852864,238.945175170898,251,2.3782982655837,0.943242014311942 +-135.34472,55.9629955,13.719616,1148449.55892315,823763.704612337,190.759918212891,151,2.28048712756086,0.587964042934698 +-135.28768,55.9537701,13.719616,1152153.70017018,823763.748213884,204.633346557617,251,2.31097640672661,0.698709807371387 +-135.23067,55.9445172,13.719616,1155857.74178979,823763.765029782,202.656723022461,251,2.30676101579113,0.683398304301393 +-135.17369,55.9352367,13.719616,1159561.69126284,823763.743111532,203.633758544922,151,2.308849777272,0.690985282191774 +-135.11674,55.9259288,13.719616,1163265.54672037,823763.702627678,192.171997070312,151,2.28369010339562,0.599598165386879 +-135.05981,55.9165934,13.719616,1166969.91496095,823763.807362873,228.566009521484,251,2.35901164611685,0.873187507459084 +-135.00292,55.9072306,13.719616,1170673.5985094,823763.71590849,214.095230102539,251,2.33060699161381,0.770013694808474 +-134.94605,55.8978404,13.719616,1174377.8003551,823763.779039045,175.308197021484,151,2.24380222321285,0.454713999428578 +-134.88921,55.8884228,13.719616,1178081.9254675,823763.819821946,168.712707519531,151,2.22714779508329,0.394220362814978 +-134.8324,55.8789777,13.719616,1181785.98132102,823763.826367002,171.606094360352,151,2.23453270717279,0.421044471387776 +-134.77562,55.8695054,13.719616,1185489.96269444,823763.829532235,146.273895263672,151,2.16516682677795,0.169087794800312 +-134.71887,55.8600057,13.719616,1189193.88020516,823763.806753122,156.510360717773,151,2.19454309238484,0.275790776305519 +-134.66215,55.8504786,13.719616,1192897.73813816,823763.756848937,178.29833984375,151,2.25114729942855,0.481393412737477 +-134.60546,55.8409243,13.719616,1196601.53435501,823763.699994263,121.827781677246,50,2.08574633635365,-0.119390095285577 +-134.54879,55.8313427,13.719616,1200305.8756309,823763.805075444,76.5229797363281,151,1.88379187272287,-0.852946350735409 +-134.49216,55.8217338,13.719616,1204009.56753034,823763.710007429,114.539474487305,151,2.05895518621762,-0.216703199535224 +-134.43555,55.8120977,13.719616,1207713.80972857,823763.7863334,102.772483825684,50,2.01187685276936,-0.387705144113469 +-134.37897,55.8024343,13.719616,1211418.01033476,823763.841494642,91.4508972167969,50,1.96118797065872,-0.571821631986695 +-134.32243,55.7927438,13.719616,1215121.56772628,823763.712698328,96.9403610229492,50,1.98650463277876,-0.479864289071902 +-134.26591,55.783026,13.719616,1218825.69126938,823763.742863103,99.1641387939453,50,1.9963546445365,-0.444086234894533 +-134.20942,55.7732811,13.719616,1222529.77929393,823763.769758011,116.029907226562,50,2.06456994499755,-0.196308793034784 +-134.15296,55.7635091,13.719616,1226233.83595237,823763.792247878,138.012329101562,151,2.1399178851085,0.0773764318914259 +-134.09653,55.7537099,13.719616,1229937.86868164,823763.798557849,87.2981109619141,151,1.94100484613749,-0.645132501085059 +-134.04013,55.7438836,13.719616,1233641.8783507,823763.798221561,163.196060180664,151,2.21270966996655,0.34177697133977 +-133.98376,55.7340303,13.719616,1237345.86578679,823763.800768617,257.577880859375,251,2.41090856585716,1.06169193281152 +-133.92742,55.7241499,13.719616,1241049.8384098,823763.794447267,232.631225585938,251,2.36666800871353,0.90099760175367 +-133.87111,55.7142424,13.719616,1244753.80034373,823763.778160879,95.9509582519531,151,1.98204931634567,-0.496047270030818 +-133.81483,55.7043079,13.65928862,1248457.75237181,823763.761453115,54.2604713439941,50,1.7344835620243,-1.39527675202733 +-133.75858,55.6943464,13.719616,1252161.69857971,823763.743233662,63.526424407959,50,1.80295441170873,-1.14657108244726 +-133.70236,55.684358,13.47997149,1255865.63969444,823763.733046445,20.2240447998047,50,1.30586801864177,-2.95213074464863 +-133.64617,55.6743425,13.37910434,1259569.58648727,823763.708559725,42.8862686157227,50,1.63231826143848,-1.76637028463502 +-133.53388,55.6542308,11.28125071,1266977.49320425,823763.676166485,20.3425178527832,50,1.3084047058087,-2.94291677281573 +-133.47777,55.6441346,13.719616,1270682.06053285,823763.857464562,176.374389648438,50,2.24643552386928,0.464278899031578 +-133.4217,55.6340115,9.790753049,1274386.04364607,823763.850681823,29.8690071105957,50,1.47522078626143,-2.33699315456168 +-156.40347,57.3618058,11.69160259,-144246.148807401,820059.777178064,11.6397066116333,20,1.06594203370266,-3.82361040364151 +-156.34181,57.3629908,13.69577157,-140542.465001272,820059.789391593,51.7841606140137,20,1.71419694102192,-1.4689635498861 +-156.28014,57.364145,10.59170427,-136838.423710406,820059.787379384,12.7668104171753,20,1.10608240930388,-3.677809102254 +-156.21846,57.3652684,13.719616,-133134.018563308,820059.772247705,31.4684982299805,20,1.49787601758767,-2.25470288793797 +-156.15679,57.366361,13.719616,-129430.442979199,820059.784096429,29.9806423187256,20,1.47684093313167,-2.33110831869302 +-156.09511,57.3674228,13.719616,-125726.490792979,820059.782852503,71.4802169799805,20,1.85418586214733,-0.960483831542467 +-156.03342,57.3684538,13.719616,-122022.155630323,820059.76966745,75.9217834472656,20,1.88036640137141,-0.865388640410764 +-155.97173,57.3694541,13.719616,-118318.030680428,820059.774683965,58.1474304199219,20,1.7645305276783,-1.28613759651418 +-155.91004,57.3704235,13.719616,-114614.110240454,820059.775090725,64.5384750366211,20,1.80981869935414,-1.12163803045637 +-155.84835,57.3713621,13.719616,-110910.387591684,820059.781571052,92.9401779174805,121,1.96820349952338,-0.546339228718962 +-155.78665,57.3722699,13.719616,-107206.256460545,820059.777520788,245.682861328125,220,2.39037486144453,0.987107657482126 +-155.72495,57.3731469,13.719616,-103502.31036437,820059.779752023,272.432769775391,220,2.4352593458129,1.15014091601533 +-155.66324,57.3739931,13.719616,-99797.9430280419,820059.772806307,287.549926757812,220,2.45871326131409,1.23533223152963 +-155.60154,57.3748084,13.719616,-96094.3481324734,820059.775718278,290.514923095703,220,2.46316844602637,1.25151473404096 +-155.53983,57.375593,13.719616,-92390.318956442,820059.780913446,288.167724609375,220,2.4596453373073,1.23871779757793 +-155.47812,57.3763467,13.719616,-88686.4495424756,820059.780709591,275.387756347656,220,2.43994462775513,1.16715919734214 +-155.4164,57.3770696,13.719616,-84982.1333434603,820059.773101475,264.82958984375,220,2.42296650791237,1.10548982003536 +-155.35468,57.3777617,13.719616,-81277.9638725605,820059.771645539,257.466339111328,220,2.41072045786737,1.06100867090124 +-155.29296,57.378423,13.719616,-77573.9347465004,820059.776001402,247.332366943359,220,2.39328095366454,0.997663413906493 +-155.23124,57.3790534,13.719616,-73870.0397884103,820059.7746807,243.10173034668,220,2.38578805007057,0.970447049365574 +-155.16952,57.379653,13.719616,-70166.272386151,820059.778536133,238.686798095703,220,2.37782839859307,0.94153532328859 +-155.10779,57.3802218,13.719616,-66462.0262589474,820059.777265095,234.668441772461,220,2.37045468957473,0.914751907467884 +-155.04607,57.3807597,13.719616,-62758.494988923,820059.779997257,234.189376831055,220,2.36956719095713,0.911528259171443 +-154.98434,57.3812668,13.719616,-59054.472201881,820059.778173678,231.835876464844,220,2.36518064364258,0.895595067279737 +-154.9226,57.3817431,13.719616,-55349.9515114711,820059.773218147,198.9990234375,220,2.29885094516978,0.654666670045695 +-154.86087,57.3821885,13.719616,-51646.1264673563,820059.770958905,156.058090209961,121,2.19328628785216,0.271225703515114 +-154.79914,57.3826031,13.67523395,-47942.3906210481,820059.773448475,65.6068725585938,35,1.8169493356857,-1.09573752401392 +-154.7374,57.3829869,13.24913108,-44238.1376891842,820059.773821614,18.3950691223145,35,1.26470142409883,-3.10165956614449 +-153.81127,57.3850426,9.892633679,11321.8647534206,820059.779702481,56.0107307434082,35,1.74827123872408,-1.34519597485899 +-152.57661,57.3769893,13.42854855,85401.6522119603,820059.776361058,38.9085731506348,30,1.59004530471359,-1.91991772936295 +-152.51489,57.3762629,13.719616,89105.9854577344,820059.783371391,83.5190658569336,30,1.92178562819353,-0.71494218636847 +-152.45318,57.3755057,13.719616,92809.8726437261,820059.782955555,65.6038436889648,31,1.81692928516842,-1.09581035321565 +-152.39147,57.3747176,13.719616,96513.9203181552,820059.777183718,47.1499671936035,31,1.67348139489642,-1.61685403478776 +-152.32977,57.3738988,12.82305171,100217.534436063,820059.773676578,23.9078426361084,31,1.37854038859988,-2.68816395420128 +-152.20636,57.3721686,13.719616,107625.888490632,820059.777404931,45.9013137817383,31,1.66182511603822,-1.65919296663398 +-152.14466,57.3712573,13.719616,111330.041020155,820059.781004469,71.643180847168,31,1.85517485961287,-0.956891510459674 +-152.08297,57.3703152,13.719616,115033.785792093,820059.774061788,80.8635482788086,31,1.90775279418411,-0.76591344486028 +-152.02128,57.3693423,13.719616,118737.72907993,820059.773245963,74.7448577880859,31,1.8735813199252,-0.890033992878441 +-151.95959,57.3683386,13.719616,122441.877260485,820059.77903511,69.6838150024414,31,1.84313191911147,-1.0006349077582 +-151.89791,57.3673041,13.719616,126145.636813895,820059.772927773,69.1785430908203,31,1.83997141147597,-1.012114773589 +-151.83623,57.3662388,13.719616,129849.614011119,820059.773311498,65.622200012207,31,1.81705078620159,-1.09536902678334 +-151.77455,57.3651427,13.719616,133553.81522638,820059.780709696,65.8000030517578,31,1.81822591375623,-1.0911006280901 +-151.71288,57.3640158,13.719616,137257.646937135,820059.774992959,62.0558242797852,31,1.79278254866902,-1.18351819234625 +-151.65121,57.3628581,13.719616,140961.71541159,820059.7762673,65.7183456420898,31,1.81768662220741,-1.09305948892452 +-151.58954,57.3616696,13.719616,144666.027021127,820059.785101386,69.0051803588867,31,1.83888169532897,-1.01607293367088 +-151.52788,57.3604503,13.719616,148369.988240295,820059.779737787,79.9969329833984,31,1.90307333681795,-0.782910569664284 +-151.46623,57.3592003,13.719616,152073.605012591,820059.770258823,117.08243560791,130,2.0684917482687,-0.182063684159882 +-151.40457,57.3579195,13.719616,155778.083903176,820059.791360781,149.985137939453,130,2.17604822685125,0.208612145727348 +-151.34293,57.3566079,13.719616,159481.631591764,820059.773302697,134.87825012207,130,2.12994192288521,0.0411408896733488 +-151.28128,57.3552655,13.719616,163186.054132031,820059.787098338,134.418090820312,130,2.12845772269628,0.0357498509542178 +-151.21965,57.3538924,13.719616,166889.557734174,820059.770845414,93.7225875854492,130,1.97184427051998,-0.533114909279783 +-151.15801,57.3524885,13.719616,170593.948896173,820059.787778262,82.2966079711914,31,1.91538193521527,-0.738202227061464 +-151.09638,57.3510538,13.719616,174298.034189024,820059.787768499,90.926139831543,31,1.95868875398792,-0.580899500282501 +-151.03476,57.3495884,13.719616,178001.819475873,820059.78100057,96.5404357910156,31,1.98470925492608,-0.486385613884718 +-150.97314,57.3480922,13.719616,181705.91149046,820059.782726497,103.278076171875,134,2.01400813944697,-0.379963702570604 +-150.91153,57.3465653,13.719616,185409.716176901,820059.776914435,107.667449951172,134,2.03208442713064,-0.314305466217332 +-150.84992,57.3450076,13.719616,189113.840287098,820059.77996282,119.755874633789,134,2.07829682695891,-0.14644883970895 +-150.78832,57.3434192,13.719616,192817.689741893,820059.774753304,143.253265380859,134,2.15610453026055,0.136170947212163 +-150.72672,57.3418,13.719616,196521.871311243,820059.77883073,187.266632080078,134,2.27246039993533,0.558808677142624 +-150.66513,57.3401501,13.719616,200225.790892612,820059.773990162,275.999298095703,231,2.44090797759583,1.17065835893097 +-150.60354,57.3384695,13.719616,203930.054703156,820059.790072934,370.797912597656,330,2.56913728062383,1.63642378781562 +-150.54196,57.3367581,13.719616,207634.069748024,820059.785486824,487.119323730469,330,2.68763535811427,2.06684262797955 +-150.48039,57.3350161,13.719616,211337.84119386,820059.781695294,564.021667480469,330,2.75129578817918,2.29807548047106 +-150.41882,57.3332433,13.719616,215041.976426028,820059.787959212,597.252380371094,330,2.77615788932182,2.38838172817131 +-150.35726,57.3314398,13.719616,218745.881283142,820059.783356859,673.1201171875,330,2.82809257028185,2.57702331305187 +-135.47523,55.9494214,13.719616,1141042.00534376,820059.836167119,602.191284179688,450,2.77973446545761,2.40137287355295 +-135.41818,55.9402586,13.719616,1144746.05661478,820059.855096875,334.852691650391,251,2.52485379428075,1.47557352565215 +-135.36116,55.9310682,13.719616,1148449.99880926,820059.835321373,192.140930175781,151,2.283619888839,0.599343126076022 +-135.30417,55.9218503,13.719616,1152153.833232,820059.786286677,189.345016479492,151,2.277253879069,0.576219961551273 +-135.24721,55.9126049,13.719616,1155857.56425147,820059.706731102,189.172317504883,151,2.27685758431484,0.574780505890396 +-135.19027,55.9033321,13.719616,1159561.79301139,820059.780707333,187.56071472168,151,2.27314187899905,0.561284003615545 +-135.13336,55.8940317,13.719616,1163265.93019395,820059.812074844,185.074035644531,151,2.2673454951049,0.540229882859307 +-135.07648,55.884704,13.719616,1166969.97077849,820059.8316955,208.652725219727,151,2.31942406141849,0.729394100413021 +-135.01963,55.8753488,13.719616,1170673.92534096,820059.816936458,225.440017700195,251,2.35303100986348,0.851464129543285 +-134.96281,55.8659662,13.719616,1174377.79507029,820059.777268784,185.162689208984,151,2.26755347962936,0.540985342016855 +-134.90602,55.8565562,13.719616,1178081.58427387,820059.711472314,181.410507202148,151,2.25866243756289,0.508690539475383 +-134.84925,55.8471189,13.719616,1181785.89397966,820059.806970584,189.01806640625,151,2.27650331616034,0.573493702835063 +-134.79252,55.8376542,13.719616,1185489.53184357,820059.696526212,183.364639282227,151,2.2633155884482,0.525592111632296 +-134.73581,55.8281622,13.719616,1189193.69875996,820059.74608125,189.656677246094,151,2.27796813752172,0.57881435212122 +-134.67913,55.8186429,13.719616,1192897.79909058,820059.776489496,181.152267456055,151,2.25804377440417,0.506443378298865 +-134.62248,55.8090963,13.719616,1196601.83708739,820059.786562908,175.133483886719,151,2.24336918707152,0.453141088562439 +-134.56586,55.7995225,13.719616,1200305.81378168,820059.785792609,148.6484375,151,2.17216034853124,0.194490261958103 +-134.50927,55.7899214,13.719616,1204009.73661103,820059.762329798,146.3935546875,151,2.16552195633117,0.170377726701683 +-134.45271,55.780293,13.719616,1207713.60981043,820059.715010497,141.082214355469,151,2.14947226751667,0.112080675890157 +-134.39617,55.7706375,13.719616,1211418.03102072,820059.846415593,112.608757019043,151,2.0515721647353,-0.243520440883115 +-134.33967,55.7609548,13.719616,1215121.80787085,820059.780453648,116.666381835938,151,2.06694572934006,-0.187679266186452 +-134.2832,55.7512449,13.719616,1218825.54444754,820059.69783012,111.37525177002,151,2.04678869879314,-0.260895354522172 +-134.22675,55.7415079,13.719616,1222529.84156262,820059.792142863,127.651496887207,151,2.10602591186289,-0.0457288886688991 +-134.17034,55.7317437,13.719616,1226233.50685512,820059.683986266,143.833053588867,151,2.1578587006623,0.142542594801405 +-134.11395,55.7219525,13.719616,1229937.73771612,820059.762258822,142.468383789062,151,2.15371849754185,0.127504195336309 +-134.05759,55.7121341,13.719616,1233641.94495637,820059.820450108,148.05712890625,151,2.17042932337752,0.18820268451602 +-134.00127,55.7022887,13.719616,1237345.52623207,820059.692417815,276.667602539062,251,2.44195830672941,1.17447345413792 +-133.94497,55.6924162,13.719616,1241049.68875194,820059.738477651,189.311569213867,151,2.27717715539123,0.575941279254488 +-133.8887,55.6825168,13.719616,1244753.83009793,820059.793039767,77.4680557250977,151,1.88912265628352,-0.833583423285982 +-133.83246,55.6725903,13.719616,1248457.96099886,820059.833724272,118.495147705078,151,2.07370056664945,-0.163143769056204 +-133.77625,55.6626368,13.719616,1252162.08222637,820059.870072985,117.762825012207,151,2.07100821540797,-0.172923157238828 +-133.72008,55.6526563,13.40666754,1255865.59796474,820059.711891275,64.5009841918945,50,1.8095663413926,-1.12255466660282 +-133.66393,55.6426489,13.03665391,1259569.70872112,820059.746373306,30.6972465515137,50,1.48709942234649,-2.29384655780045 +-133.55172,55.6225534,12.38374256,1266977.93176234,820059.823359817,132.63069152832,50,2.12264403401633,0.0146328742766862 +-133.49566,55.6124653,13.719616,1270682.05211394,820059.863719205,198.357070922852,50,2.29744768657494,0.649569634299348 +-133.43964,55.6023503,13.719616,1274385.58382535,820059.712011297,177.32878112793,50,2.24877922894909,0.472791904841473 +-133.38364,55.5922084,13.63782546,1278089.73070738,820059.750411439,56.2388076782227,50,1.75003610461032,-1.33878547821732 +-133.27173,55.5718443,10.15334504,1285498.07265841,820059.861760859,31.2007598876953,50,1.49416517129454,-2.26818174085561 +-133.21583,55.5616221,13.24130717,1289201.6757701,820059.738489445,12.2514562606812,50,1.08818771387516,-3.74280774370572 +-156.40124,57.3286515,12.31792161,-144246.181754749,816355.773232753,21.6229228973389,20,1.33491439971838,-2.84662599791581 +-156.27802,57.3309886,13.45352047,-136838.200148932,816355.773976385,21.4557037353516,20,1.33154276372386,-2.85887274220865 +-156.2164,57.332111,13.719616,-133133.965442456,816355.765441024,81.5745697021484,20,1.91155479160517,-0.752103505028886 +-156.15478,57.3332027,13.719616,-129429.959716349,816355.772147977,191.795806884766,20,2.28283910822195,0.596507108017921 +-156.09316,57.3342635,13.719616,-125726.177335153,816355.771244487,36.5793914794922,20,1.56323647644666,-2.01729504562982 +-156.03153,57.3352936,13.719616,-122022.010760182,816355.766153903,108.068634033203,20,2.03369966210363,-0.308438471761487 +-155.9699,57.336293,13.719616,-118318.054104108,816355.775860898,140.293319702148,121,2.14703699187251,0.103235059653665 +-155.90827,57.3372615,13.719616,-114614.301666687,816355.77755586,125.240608215332,121,2.09774516804677,-0.0758069137686371 +-155.84663,57.3381993,13.719616,-110910.145968783,816355.776382476,124.190422058105,121,2.09408810302485,-0.0890904177585213 +-155.78499,57.3391063,13.719616,-107206.181420612,816355.778536723,252.106735229492,220,2.40158444834971,1.02782407665636 +-155.72335,57.3399825,13.719616,-103502.401646912,816355.783573278,266.611755371094,220,2.42587929429107,1.11606989155479 +-155.6617,57.3408279,13.719616,-99798.199818068,816355.776034582,278.971343994141,220,2.44555959472743,1.18755436005666 +-155.60005,57.3416425,13.719616,-96094.170010914,816355.771648325,287.002868652344,220,2.45788623761781,1.2323282454087 +-155.5384,57.3424264,13.719616,-92390.3055893783,816355.781176173,281.307159423828,220,2.44918078534222,1.20070755796027 +-155.47674,57.3431794,13.719616,-88686.0002493084,816355.768555929,270.179412841797,220,2.43165225353192,1.13703892728417 +-155.41509,57.3439017,13.719616,-84982.44801223,816355.783007349,263.124572753906,220,2.42016140799866,1.09530089649355 +-155.35343,57.3445931,13.719616,-81278.442077677,816355.775701074,252.841934204102,220,2.40284910395819,1.03241766679501 +-155.29176,57.3452538,13.719616,-77573.9756002307,816355.770295229,248.697891235352,220,2.39567210280619,1.00634875009088 +-155.2301,57.3458837,13.719616,-73870.243344339,816355.779222676,241.883422851562,220,2.38360610560543,0.962521604279228 +-155.16843,57.3464827,13.719616,-70166.0382181126,816355.768206906,238.098190307617,220,2.37675609451281,0.937640408803008 +-155.10676,57.347051,13.719616,-66461.9538902591,816355.770960333,235.351318359375,220,2.37171663542187,0.919335654979913 +-155.04509,57.3475885,13.719616,-62757.9841853976,816355.776040933,236.411422729492,220,2.3736684565939,0.926425226581925 +-154.98342,57.3480951,13.719616,-59054.122886216,816355.772021135,224.905914306641,220,2.35200087614246,0.847722389839123 +-154.92175,57.348571,13.719616,-55350.3632686249,816355.78097886,155.910278320312,121,2.19287474681587,0.269730869005794 +-154.86007,57.349016,13.719616,-51646.0988158179,816355.772576352,139.632904052734,35,2.14498777046981,0.0957917026130469 +-154.79839,57.3494303,10.04123931,-47941.9232979471,816355.777814658,11.8349580764771,35,1.07316672384627,-3.79736826690806 +-152.57793,57.3438214,13.64193791,85401.756102313,816355.77374521,50.6704788208008,30,1.70475500826243,-1.50325934466447 +-152.51627,57.3430957,13.719616,89105.9255745328,816355.782649141,94.681396484375,30,1.97626465484413,-0.517058811711169 +-152.45462,57.3423391,13.719616,92809.6484651293,816355.76957067,75.8755340576172,31,1.88010176091969,-0.866349890067317 +-152.39297,57.3415518,13.719616,96513.5310972179,816355.77006448,54.7570495605469,31,1.73844003927761,-1.38090569735226 +-152.33132,57.3407337,13.719616,100217.580098278,816355.773355309,37.529857635498,31,1.5743769169781,-1.97682978582134 +-152.26967,57.3398848,13.719616,103921.801845697,816355.779844892,46.6997718811035,31,1.669314759131,-1.63198844516404 +-152.20803,57.3390051,13.719616,107625.602262559,816355.773744102,71.3229446411133,31,1.85322926516775,-0.963958464812284 +-152.14639,57.3380946,13.719616,111329.588178395,816355.770575366,70.8196105957031,31,1.85015353444409,-0.975130396701568 +-152.08475,57.3371533,13.719616,115033.76596838,816355.770785704,78.383674621582,31,1.89422561931647,-0.815048005019661 +-152.02312,57.3361813,13.719616,118737.541221031,816355.768117686,75,31,1.8750612633917,-0.8846584157902 +-151.96149,57.3351785,13.719616,122441.521075092,816355.768651882,72.9601440429688,31,1.86308568273545,-0.92815714290474 +-151.89986,57.3341449,13.719616,126145.711903304,816355.77288053,69.3317794799805,31,1.84093234700994,-1.00862438145131 +-151.83824,57.3330805,13.719616,129849.51962396,816355.761758499,66.7724685668945,31,1.82459743232399,-1.06795745403955 +-151.77662,57.3319854,13.719616,133553.550687919,816355.765403399,62.6226768493652,31,1.79673162789382,-1.16917400942236 +-151.715,57.3308595,13.719616,137257.811818258,816355.773193608,63.6389999389648,31,1.80372334626679,-1.14377809265663 +-151.65339,57.3297029,13.719616,140961.708536104,816355.775613512,63.1394424438477,31,1.80030074251297,-1.15620996639886 +-151.59178,57.3285155,13.719616,144665.848036912,816355.78218244,72.3265533447266,31,1.85929776968675,-0.941915924275617 +-151.53018,57.3272973,13.719616,148369.636234262,816355.771141782,75.4079971313477,31,1.87741740589424,-0.876100233710959 +-151.46858,57.3260484,13.719616,152073.679522426,816355.775471127,86.3423080444336,31,1.93622365374304,-0.66249915654988 +-151.40698,57.3247687,13.719616,155777.98467126,816355.784625873,131.018218994141,130,2.11733169152185,-0.00466306995674638 +-151.34539,57.3234583,13.719616,159481.957145058,816355.786374798,150.334320068359,130,2.17705813770489,0.212280430205 +-151.28381,57.3221171,13.719616,163185.60373221,816355.768530922,151.111099243164,130,2.17929636482232,0.220410309949143 +-151.22223,57.3207452,13.719616,166889.530781258,816355.766363124,103.224403381348,130,2.0137823814093,-0.380783720201192 +-151.16065,57.3193425,13.719616,170593.745099012,816355.769388442,87.660514831543,31,1.94280401694356,-0.638597399182958 +-151.09908,57.3179092,13.719616,174297.651616324,816355.774356747,90.9302368164062,31,1.95870832215431,-0.580828423116854 +-151.03751,57.316445,13.719616,178001.858576595,816355.773637731,94.7046432495117,134,1.97637127243734,-0.516671546180952 +-150.97595,57.3149502,13.719616,181705.770389711,816355.774048074,102.590065002441,134,2.01110530499088,-0.390507625866586 +-150.91439,57.3134246,13.719616,185409.994840102,816355.780258034,104.870826721191,134,2.02065469166255,-0.35582152780875 +-150.85284,57.3118684,13.719616,189113.93677096,816355.786842501,119.712028503418,134,2.07813778992358,-0.147026507614956 +-150.7913,57.3102814,13.719616,192817.6035519,816355.770585047,146.58528137207,134,2.16609036498586,0.172442349175498 +-150.72976,57.3086637,13.719616,196521.601438858,816355.771332373,267.610015869141,134,2.42750236378673,1.1219653432332 +-150.66822,57.3070152,13.719616,200225.937311234,816355.778724965,392.641540527344,231,2.59399624500273,1.72671864189461 +-150.60669,57.3053361,13.719616,203930.015924199,816355.785162342,492.726440429688,330,2.69260586778457,2.08489693782678 +-150.54517,57.3036263,13.719616,207633.844144042,816355.77864103,597.365966796875,430,2.77624047629732,2.38868170763899 +-135.43456,55.9083201,13.719616,1144745.71478941,816355.749228871,593.352600097656,450,2.77331284980313,2.37804773258427 +-135.37758,55.8991373,13.719616,1148449.94651018,816355.823630231,409.547790527344,251,2.61230458729618,1.79321976682559 +-135.32063,55.8899269,13.719616,1152154.06976065,816355.855444225,199.545303344727,151,2.30004151034368,0.658991142578441 +-135.26371,55.8806891,13.719616,1155858.08273037,816355.864821569,199,151,2.29885307640971,0.65467441131743 +-135.20682,55.8714238,13.719616,1159561.99286675,816355.839791216,204,151,2.3096301674259,0.693819881976265 +-135.14996,55.862131,13.719616,1163265.8045268,816355.779101505,185,151,2.26717172840301,0.539598712600118 +-135.09313,55.8528108,13.719616,1166969.51893153,816355.692206132,190,151,2.27875360095283,0.581667379496592 +-135.03632,55.8434633,13.719616,1170673.73771344,816355.764832787,221,251,2.34439227368511,0.820085774002676 +-134.97954,55.8340883,13.719616,1174377.87100174,816355.799193617,193.381149291992,151,2.28641413697824,0.609492632875541 +-134.92279,55.824686,13.719616,1178081.91681553,816355.815447233,190.5859375,151,2.28009085280042,0.586524659896709 +-134.86607,55.8152563,13.719616,1181785.88259598,816355.80168068,192.724304199219,151,2.28493648639406,0.604125384190356 +-134.80938,55.8057993,13.719616,1185489.76946318,816355.767366264,192.584747314453,151,2.28462188808718,0.602982673344476 +-134.75272,55.796315,13.719616,1189193.58168025,816355.711293025,190.208923339844,151,2.27923088729303,0.583401019715304 +-134.69608,55.7868034,13.719616,1192897.92395828,816355.811881458,185.508941650391,151,2.26836484772914,0.543932462542774 +-134.63948,55.7772646,13.719616,1196601.59643888,816355.71992206,180.654479980469,151,2.25684873593821,0.502102657492541 +-134.5829,55.7676985,13.719616,1200305.80746045,816355.783352491,178.239608764648,151,2.25100422021973,0.480873708212168 +-134.52635,55.7581051,13.719616,1204009.96080998,816355.821370605,179.897247314453,151,2.25502451806879,0.495476577507198 +-134.46983,55.7484846,13.719616,1207714.05426195,816355.854136988,170.805191040039,151,2.23250106545009,0.413664968762678 +-134.41335,55.7388369,13.719616,1211417.49477711,816355.687396597,159.088592529297,151,2.20163903961393,0.301565282026544 +-134.35688,55.729162,13.719616,1215122.08791274,816355.867222009,152.562362670898,151,2.183447405831,0.23548807571774 +-134.30045,55.7194599,13.719616,1218826.03649894,816355.845221264,145.887420654297,151,2.16401784586226,0.164914368162707 +-134.24405,55.7097308,13.719616,1222529.93864193,816355.823966695,149.875885009766,151,2.17573176060214,0.207462649982094 +-134.18768,55.6999745,13.719616,1226233.80501779,816355.780998349,156.260101318359,151,2.19384810156827,0.273266371289617 +-134.13134,55.6901911,13.719616,1229937.63651611,816355.725832157,154.246932983398,151,2.18821653736247,0.252810922685688 +-134.07502,55.6803807,13.719616,1233642.0344384,816355.853738547,187.100463867188,251,2.27207486422214,0.55740830138947 +-134.01874,55.6705432,13.719616,1237345.80528834,816355.781981378,200.264297485352,251,2.30160353148455,0.664664849207294 +-133.96249,55.6606787,13.719616,1241049.55033815,816355.705282869,109.011428833008,151,2.0374720320591,-0.294736147341649 +-133.90626,55.6507871,13.719616,1244753.87745889,816355.799318984,90.2151565551758,151,1.955279507113,-0.593282858028143 +-133.85007,55.6408686,13.719616,1248457.58320358,816355.709948356,81.1309051513672,151,1.90918632128848,-0.760706465247847 +-133.7939,55.6309231,13.719616,1252161.87587655,816355.800848624,105.410331726074,151,2.02288318005793,-0.347727021882821 +-133.73777,55.6209507,13.36437416,1255865.55530387,816355.70501419,97.7309722900391,50,1.99003221943026,-0.467051087480197 +-133.68166,55.6109513,12.77065962,1259569.82979643,816355.788374559,46.7775917053223,50,1.67003785885807,-1.6293619405621 +-133.56954,55.5908718,13.66513522,1266977.76831123,816355.763797093,176.73616027832,50,2.24732541539633,0.46751123905813 +-133.51352,55.5807918,13.719616,1270682.03747146,816355.854536503,206.315979003906,50,2.31453286502833,0.711627879037504 +-133.45754,55.5706849,12.94062936,1274385.71356806,816355.750336776,63.3105812072754,50,1.80147630047383,-1.15194000434736 +-133.2339,55.5299892,13.63822988,1289201.74221748,816355.754471187,54.7109565734863,50,1.7380743081051,-1.38223413736088 +-133.17807,55.5197484,13.13925382,1292905.49474336,816355.678370274,19.2196922302246,50,1.28374642892122,-3.032482672644 +-156.27591,57.2978312,13.719616,-136838.340977349,812651.785267864,24.5218391418457,20,1.38955303922329,-2.64816286381362 +-156.21435,57.2989526,13.719616,-133134.283401851,812651.782961071,98.9300308227539,20,1.99532814438672,-0.447814776430864 +-156.15279,57.3000432,13.719616,-129430.454844638,812651.781325395,176.819244384766,20,2.24752953033363,0.468252642770605 +-156.09122,57.3011031,13.719616,-125726.247575951,812651.772053398,177.047470092773,20,2.24808972531837,0.470287430850763 +-156.02965,57.3021323,13.719616,-122022.256270295,812651.774673562,162.726425170898,20,2.21145808381599,0.337230853202678 +-155.96808,57.3031308,13.719616,-118318.474589966,812651.788682336,204.292526245117,121,2.31025247886996,0.696080294766475 +-155.9065,57.3040984,13.719616,-114614.295825999,812651.774013498,221.636993408203,121,2.3456422501547,0.824626045319025 +-155.84492,57.3050354,13.719616,-110910.313657919,812651.782045356,205.861770629883,220,2.31357570384971,0.708151196435763 +-155.78333,57.3059415,13.719616,-107205.921664526,812651.762696679,251.375701904297,220,2.40032329626611,1.02324321232009 +-155.72175,57.306817,13.719616,-103502.314597172,812651.7818472,263.780334472656,220,2.42124241460548,1.0992274210395 +-155.66016,57.3076616,13.719616,-99798.2849597133,812651.773858928,277.867004394531,220,2.44383697909061,1.18129732838025 +-155.59857,57.3084755,13.719616,-96094.4268214983,812651.776781756,281.233703613281,220,2.44906736619185,1.2002955872331 +-155.53697,57.3092587,13.719616,-92390.1328280438,812651.776305375,275.577209472656,220,2.44024329810666,1.16824405330788 +-155.47537,57.3100111,13.719616,-88685.997894849,812651.775912159,268.658996582031,220,2.42920138836465,1.12813668545009 +-155.41377,57.3107327,13.719616,-84982.0156463719,812651.775232976,257.900024414062,220,2.41145138325035,1.06366360051911 +-155.35217,57.3114235,13.719616,-81278.1797064501,812651.773913845,252.565216064453,220,2.40237353817707,1.030690276138 +-155.29057,57.3120836,13.719616,-77574.4834813727,812651.782778064,245.866455078125,220,2.39069927957953,0.988286036746602 +-155.22896,57.3127129,13.719616,-73870.3198201333,812651.779216756,241.103454589844,220,2.38220343310063,0.957426697379212 +-155.16735,57.3133114,13.719616,-70166.283356167,812651.775159825,237.990051269531,220,2.3765588025647,0.93692378813474 +-155.10574,57.3138792,13.719616,-66462.3675251895,812651.781476375,236.305236816406,220,2.37347334624205,0.925716530093967 +-155.04412,57.3144162,13.719616,-62757.9651435666,812651.777275386,234.699966430664,220,2.37051302748109,0.914963807395064 +-154.98251,57.3149224,13.719616,-59054.2718545684,812651.781750979,212.966583251953,220,2.32831146330812,0.761675680793218 +-154.92089,57.3153978,13.719616,-55350.0792557385,812651.776312556,131.888122558594,121,2.12020568607309,0.00577609857303855 +-154.85927,57.3158424,13.719616,-51645.9819781639,812651.770176749,89.8817977905273,22,1.95367175047047,-0.599122689053242 +-154.79765,57.3162563,13.71166067,-47941.9735071344,812651.774288917,56.8562240600586,22,1.75477801391346,-1.32156151015261 +-153.74999,57.3185818,7.925333437,15025.9550626139,812651.771653993,11.5968532562256,35,1.06434016173967,-3.82942885983084 +-153.13375,57.3157936,9.429704762,52065.558658863,812651.772609809,50.011905670166,30,1.69907340336329,-1.52389655534965 +-153.07213,57.3153455,10.16458601,55769.6664292945,812651.777412579,92.9001770019531,30,1.96801654145218,-0.547018313796686 +-153.01051,57.3148666,13.6205922,59473.8702460293,812651.781543668,28.9976291656494,30,1.46236249161046,-2.38369815085669 +-152.9489,57.3143569,13.37095311,63177.5754779328,812651.775724976,74.5477981567383,30,1.87243482065957,-0.894198405454703 +-152.57925,57.3106525,13.719616,85401.7126155351,812651.777394212,64.3285522460938,30,1.80840377744408,-1.12677743069262 +-152.51765,57.3099274,13.719616,89105.7118676819,812651.776906714,100.806381225586,30,2.00348802460299,-0.418175762423685 +-152.45605,57.3091715,13.719616,92809.8645290718,812651.776174382,84.0475082397461,31,1.92452484241832,-0.70499257845445 +-152.39446,57.3083849,13.719616,96513.5756939704,812651.772196286,68.7784729003906,31,1.83745252888209,-1.02126407413064 +-152.33286,57.3075675,13.719616,100218.054009011,812651.782704572,47.5,31,1.67669360962487,-1.60518635403669 +-152.27128,57.3067193,13.719616,103921.502814357,812651.762828583,67.2886581420898,31,1.82794186776917,-1.05580950990572 +-152.20969,57.3058404,13.719616,107625.731216468,812651.769416131,72.4218063354492,31,1.85986935273361,-0.939839771503378 +-152.14811,57.3049308,13.719616,111329.543534342,812651.77104315,75,31,1.8750612633917,-0.8846584157902 +-152.08653,57.3039904,13.719616,115033.547441819,812651.772643465,76.7754974365234,31,1.88522263896385,-0.847749399366806 +-152.02495,57.3030192,13.719616,118737.74931005,812651.77467818,75.2357482910156,31,1.87642424480067,-0.879707678279194 +-151.96338,57.3020173,13.719616,122441.554155723,812651.770345575,74.945198059082,31,1.87474381165725,-0.885811491099459 +-151.90181,57.3009846,13.719616,126145.569681292,812651.766298677,68.2378005981445,31,1.8340250204531,-1.03371376305306 +-151.84024,57.2999212,13.719616,129849.801892388,812651.774202058,63.0453453063965,31,1.79965302774701,-1.15856265130504 +-151.77868,57.2988271,13.719616,133553.656114401,812651.774465819,63.2183570861816,31,1.80084320523851,-1.15423958694544 +-151.71712,57.2977022,13.719616,137257.74007816,812651.775462248,58.6905403137207,31,1.76856810771066,-1.27147195339654 +-151.65556,57.2965466,13.719616,140962.059755518,812651.788899925,63.0179862976074,31,1.799464521437,-1.15924736002804 +-151.59401,57.2953602,13.719616,144666.020873441,812651.78240378,69.9948196411133,31,1.84506589880667,-0.993610141492465 +-151.53247,57.2941431,13.719616,148369.629381144,812651.766038401,69.4011154174805,31,1.84136645050909,-1.00704759363693 +-151.47093,57.2928953,13.719616,152073.492621851,812651.761624612,84.7735977172852,31,1.9282606146261,-0.69142318750028 +-151.40939,57.2916168,13.719616,155777.616926428,812651.769772485,106.064018249512,31,2.02556807639873,-0.337974712027318 +-151.34785,57.2903075,13.719616,159482.009070391,812651.779951898,154.615829467773,130,2.18925395464429,0.256579118361622 +-151.28632,57.2889676,13.719616,163186.073490011,812651.790541613,151.262725830078,130,2.17973192233468,0.221992379154533 +-151.2248,57.2875969,13.719616,166889.817414656,812651.77821338,130.245498657227,130,2.1147627228191,-0.0139942975418319 +-151.16328,57.2861955,13.719616,170593.847736364,812651.778806678,92.328010559082,31,1.96533347768646,-0.556763967216422 +-151.10177,57.2847634,13.719616,174297.569769087,812651.766761042,94.6261367797852,134,1.97601110988432,-0.517979759374136 +-151.04026,57.2833006,13.719616,178001.590848226,812651.767906024,101.75511932373,134,2.00755626790334,-0.40339874156455 +-150.97875,57.2818071,13.719616,181705.91729664,812651.782956318,118.116607666016,134,2.07231096544267,-0.168191197270928 +-150.91725,57.2802829,13.719616,185409.95442462,812651.784722973,110.809463500977,134,2.04457685218616,-0.268929412722607 +-150.85576,57.278728,13.719616,189113.708552506,812651.772277272,118.532318115234,134,2.07383677790326,-0.162649010903807 +-150.79427,57.2771424,13.719616,192817.787010664,812651.773739369,167.058563232422,134,2.22286874198715,0.378677620606427 +-150.73279,57.2755262,13.719616,196521.594556488,812651.77144225,384.382232666016,231,2.58476330502814,1.69318196856348 +-150.67131,57.2738792,13.719616,200225.739605365,812651.7723499,508.412689208984,330,2.70621638134828,2.13433420791749 +-150.60984,57.2722016,13.719616,203929.626352636,812651.768859494,611.505126953125,430,2.78640010257936,2.4255843701414 +-135.33707,55.8579999,13.719616,1152153.81323224,812651.783587571,564,450,2.75127910398334,2.29801487870963 +-135.2802,55.8487696,13.719616,1155857.50656034,812651.697143922,592,351,2.77232170672292,2.37444761801656 +-135.22335,55.8395118,13.719616,1159561.6942932,812651.747151559,319,251,2.50379068305718,1.39906629367766 +-135.16653,55.8302266,13.719616,1163265.77665778,812651.769563998,194,251,2.28780172993023,0.614532766535627 +-135.10974,55.820914,13.719616,1166969.75797795,812651.763122762,191,151,2.28103336724773,0.589948141389748 +-135.05298,55.811574,13.719616,1170673.64257197,812651.726577678,187,251,2.2718416065365,0.556561042896859 +-134.99624,55.8022067,13.719616,1174378.03261803,812651.846213222,197,151,2.29446622616159,0.638740119084559 +-134.93954,55.792812,13.719616,1178081.7335282,812651.756986674,182,151,2.26007138798507,0.513808249563239 +-134.88286,55.78339,13.719616,1181785.94846259,812651.822585725,198.234817504883,151,2.29717993532712,0.648597085343479 +-134.82621,55.7739407,13.719616,1185490.0806785,812651.864949837,205.123458862305,151,2.31201533112337,0.702483477318992 +-134.7696,55.7644641,13.719616,1189193.53342764,812651.703795628,198.784255981445,151,2.29838198463299,0.652963271521431 +-134.71301,55.7549602,13.719616,1192897.51299006,812651.695486979,200.317031860352,251,2.30171787654521,0.665080183104935 +-134.65644,55.745429,13.719616,1196602.02361751,812651.840495517,195.355911254883,251,2.2908265570327,0.625519801943434 +-134.59991,55.7358707,13.719616,1200305.86111496,812651.799166823,199.418640136719,151,2.29976575041577,0.65798950381056 +-134.54341,55.7262851,13.719616,1204009.63711661,812651.728583618,197.089614868164,151,2.29466374084832,0.639457548803046 +-134.48693,55.7166723,13.719616,1207713.95364132,812651.820088676,192.502182006836,151,2.2844356565882,0.602306227384386 +-134.43049,55.7070324,13.719616,1211417.60963219,812651.720015959,189.729476928711,151,2.27813480939672,0.579419751944115 +-134.37407,55.6973653,13.719616,1215121.81452671,812651.780792473,187.222778320312,151,2.27235868573228,0.558439222125037 +-134.31768,55.6876711,13.719616,1218825.96825001,812651.830058718,189.989593505859,151,2.27872981354886,0.581580976855776 +-134.26132,55.6779498,13.719616,1222530.07496028,812651.866651252,184.484176635742,151,2.2659591222865,0.535194181072703 +-134.205,55.6682013,13.719616,1226233.54107115,812651.694119774,190.707595825195,151,2.28036799120684,0.587531305692018 +-134.1487,55.6584258,13.719616,1229937.56621637,812651.701350752,198.475692749023,251,2.29770732645748,0.650512720461338 +-134.09243,55.6486233,13.719616,1233641.55349893,812651.703109931,209.12483215332,251,2.32040560539942,0.732959348312309 +-134.03619,55.6387937,13.719616,1237345.51032682,812651.68761321,149.823715209961,151,2.1755805621595,0.206913454082105 +-133.97997,55.6289371,13.719616,1241050.038533,812651.851249565,114.14234161377,151,2.05744677779334,-0.222182169474809 +-133.92379,55.6190535,13.719616,1244753.9401922,812651.819702706,98.3992004394531,151,1.99299156950711,-0.456301883318462 +-133.86764,55.609143,13.719616,1248457.81708127,812651.788804381,101.628120422363,151,2.00701389352373,-0.405368800120351 +-133.81152,55.5992054,13.719616,1252161.67992967,812651.736172775,97.8228378295898,151,1.99044025750238,-0.465568976736583 +-133.75543,55.589241,13.3123304,1255865.52281242,812651.692597503,95.0029144287109,50,1.97773692845614,-0.511711093723646 +-133.69936,55.5792496,11.14172483,1259569.95746791,812651.82537734,34.0043716430664,50,1.53153475405442,-2.1324447499309 +-133.64333,55.5692314,13.6049128,1263273.77921872,812651.77590044,62.1813926696777,50,1.7936604446609,-1.18032942352727 +-133.58733,55.5591862,13.09960851,1266977.59982761,812651.710934597,169.981323242188,50,2.23040120574032,0.406037678937135 +-133.53135,55.5491142,13.719616,1270682.0176041,812651.841974292,81.2658920288086,50,1.90990830682664,-0.758084007698066 +-133.47541,55.5390154,12.91542372,1274385.83452404,812651.785821288,37.9287185668945,50,1.57896817018163,-1.96015304371199 +-133.25194,55.4983522,13.71875743,1289201.78453481,812651.769758941,29.7521591186523,50,1.47351848802394,-2.34317638764453 +-133.19615,55.4881195,11.84891715,1292905.65857488,812651.726680226,38.3806610107422,50,1.5841124500984,-1.94146755073059 +-156.2738,57.2646726,13.719616,-136838.2470312,808947.779322113,31.4709758758545,20,1.49791021005423,-2.25457869113993 +-156.2123,57.265793,13.719616,-133134.373257263,808947.783432771,175.828918457031,20,2.24509030471649,0.459392679104859 +-156.15079,57.2668827,13.719616,-129430.126247117,808947.776465822,95.0997085571289,20,1.97817918599919,-0.510104688094389 +-156.08928,57.2679416,13.719616,-125726.10158828,808947.767335193,167.530715942383,121,2.22409444445536,0.383129721821284 +-156.02777,57.2689699,13.719616,-122022.292234494,808947.777839762,199.513320922852,121,2.2999718975674,0.658738289105508 +-155.96625,57.2699674,13.719616,-118318.090974185,808947.767343953,217.492034912109,121,2.33744335666049,0.794845323950887 +-155.90473,57.2709343,13.719616,-114614.092369765,808947.776609398,239.010986328125,220,2.37841786409467,0.943676430240593 +-155.84321,57.2718704,13.719616,-110910.29073569,808947.782845214,226.416488647461,220,2.35490805090782,0.858282078377194 +-155.78168,57.2727757,13.719616,-107206.07813491,808947.769450096,248.514907836914,220,2.39535244617645,1.00518766597256 +-155.72015,57.2736504,13.719616,-103502.049189448,808947.77555924,265.689971923828,220,2.42437516291486,1.11060645707455 +-155.65862,57.2744943,13.719616,-99798.1981494038,808947.778424949,274.677093505859,220,2.43882244326183,1.16308310295912 +-155.59708,57.2753075,13.719616,-96093.916807006,808947.774324931,278.9951171875,220,2.44559660256721,1.18768878309383 +-155.53555,57.2760899,13.719616,-92390.402218558,808947.781197502,273.935821533203,220,2.43764882698557,1.15882019366032 +-155.47401,57.2768416,13.719616,-88686.4446265374,808947.781439076,264.948699951172,220,2.42316179286179,1.10619915071154 +-155.41246,57.2775626,13.719616,-84982.0376896914,808947.776355229,255.974670410156,220,2.40819699247845,1.05184272433997 +-155.35092,57.2782528,13.719616,-81278.3784313412,808947.780582236,248.295913696289,220,2.39496957225792,1.00379695861739 +-155.28937,57.2789123,13.719616,-77574.2571231269,808947.779908673,245.594436645508,220,2.39021852467791,0.986539797722808 +-155.22782,57.279541,13.719616,-73870.2691974587,808947.775646293,241.358184814453,220,2.38266203097522,0.959092455756596 +-155.16627,57.280139,13.719616,-70166.4080836625,808947.778649228,236.933197021484,220,2.37462591455639,0.929902987187426 +-155.10471,57.2807063,13.719616,-66462.0658685766,808947.778617241,236.023406982422,220,2.37295507508544,0.923834021323844 +-155.04316,57.2812428,13.719616,-62758.4395210698,808947.784683359,223.688339233398,220,2.34964334512218,0.839159164267111 +-154.9816,57.2817485,13.719616,-59054.3195269205,808947.777126899,199.074172973633,220,2.29901492018514,0.655262274104608 +-154.92004,57.2822235,13.719616,-55350.3009239823,808947.776870636,146.938720703125,121,2.16713625441409,0.176241318105376 +-154.85848,57.2826678,13.719616,-51646.3773663292,808947.783682161,87.2040786743164,22,1.94053679805555,-0.6468325853129 +-154.79691,57.2830812,12.30189646,-47941.9412065221,808947.767798653,29.3872089385986,22,1.46815834074681,-2.36264597249343 +-152.94987,57.2811835,11.4828361,63177.8374879413,808947.773904584,91.2877731323242,30,1.96041261305724,-0.574637952104342 +-152.88831,57.2806435,12.99842352,66882.0780599983,808947.776031789,32.1792411804199,30,1.50757579877352,-2.2194705140778 +-152.76521,57.2794713,11.9058075,74289.707095593,808947.770554084,23.5454444885254,30,1.37190689342354,-2.71225870206977 +-152.64211,57.2781761,13.719616,81697.846686262,808947.771965271,43.6309127807617,30,1.63979429874207,-1.73921518327491 +-152.58057,57.2774824,13.719616,85401.5222082992,808947.765968255,85.1245346069336,30,1.93005475055147,-0.684906373721961 +-152.51902,57.276758,13.719616,89105.9458841181,808947.780545761,102.400001525879,30,2.0102999631113,-0.393432857440652 +-152.45748,57.2760028,13.719616,92809.9211766897,808947.778614261,67.8167953491211,31,1.83133726354475,-1.04347646330638 +-152.39594,57.2752169,13.719616,96514.0557576612,808947.784564069,58.8796691894531,31,1.7699653612887,-1.26639672958523 +-152.33441,57.2744002,13.719616,100217.754678464,808947.772528506,65.8524780273438,31,1.81857212209739,-1.08984310057731 +-152.27288,57.2735528,13.719616,103921.625588735,808947.768042921,75.0288543701172,31,1.87522831517554,-0.884051636029958 +-152.21135,57.2726747,13.719616,107625.674827622,808947.771521633,78.5367202758789,31,1.89507276100585,-0.811970944605541 +-152.14982,57.2717659,13.719616,111329.908733554,808947.783393935,78.7779159545898,31,1.89640448749885,-0.807133733870378 +-152.0883,57.2708263,13.719616,115033.732396455,808947.775623357,77.5393981933594,31,1.8895224259939,-0.832131345592277 +-152.02678,57.269856,13.719616,118737.75342163,808947.776035083,75.4516983032227,31,1.87766901953132,-0.875186301163385 +-151.96526,57.268855,13.719616,122441.978145163,808947.785103359,78.5699768066406,31,1.89525662494393,-0.811303098302413 +-151.90375,57.2678232,13.719616,126145.811685568,808947.773164433,66.6697845458984,31,1.82392905163556,-1.07038520347475 +-151.84224,57.2667608,13.719616,129849.861251982,808947.780918676,63.1058235168457,31,1.80006943855526,-1.15705012839399 +-151.78074,57.2656676,13.719616,133553.532323837,808947.766458843,55.6093521118164,31,1.74514783526927,-1.35654106771496 +-151.71923,57.2645437,13.719616,137258.034019526,808947.781139972,52.9504280090332,31,1.72386947494794,-1.43383014585073 +-151.65774,57.2633891,13.719616,140961.567963531,808947.763507453,56.5308532714844,31,1.75228554071044,-1.33061488424869 +-151.59624,57.2622038,13.719616,144665.945193736,808947.776129058,64.9795532226562,31,1.81277672095784,-1.11089365168832 +-151.53475,57.2609879,13.719616,148369.968487418,808947.787730854,69.9197692871094,31,1.84459998659573,-0.995302467627167 +-151.47327,57.2597412,13.719616,152073.644991584,808947.77492095,80.3053512573242,31,1.90474448605195,-0.776840478652935 +-151.41179,57.2584638,13.719616,155777.582198977,808947.771248094,95.8653182983398,134,1.98166151857976,-0.497455862205117 +-151.35031,57.2571557,13.719616,159481.786436195,808947.777336074,156.164474487305,134,2.19358224408098,0.272300701012494 +-151.28884,57.2558169,13.719616,163185.66245969,808947.769251527,155.315811157227,134,2.19121566917871,0.263704625479729 +-151.22737,57.2544475,13.719616,166889.817696973,808947.782258673,140.043472290039,134,2.14626287028571,0.100423229094142 +-151.16591,57.2530473,13.719616,170593.65782381,808947.769030073,98.8644561767578,134,1.99504018178084,-0.44886073880812 +-151.10445,57.2516165,13.719616,174297.789789136,808947.77712876,100.035385131836,134,2.00015364849222,-0.430287168183683 +-151.043,57.250155,13.719616,178001.618810741,808947.769296027,113.06224822998,134,2.05331761710647,-0.237180459669337 +-150.98155,57.2486628,13.719616,181705.752777361,808947.771932652,134.875778198242,134,2.12993396346466,0.0411119787860656 +-150.92011,57.24714,13.719616,185409.595920833,808947.76899984,133.851150512695,134,2.12662210850142,0.0290823762620292 +-150.85867,57.2455865,13.719616,189113.756624298,808947.776890977,158.832153320312,134,2.20093842375911,0.299020445266169 +-150.79724,57.2440023,13.719616,192817.639634569,808947.767329914,326.229705810547,134,2.51352350447314,1.43441867908424 +-150.73581,57.2423875,13.719616,196521.852286779,808947.780157949,539.211120605469,231,2.73175884044082,2.22711170988525 +-150.67439,57.240742,13.719616,200225.799852937,808947.774862005,634.708740234375,430,2.80257447879202,2.48433432117235 +-135.29665,55.8168464,13.719616,1155857.64158141,808947.727223428,571,450,2.75663610824585,2.3174730472323 +-135.18307,55.7983186,13.719616,1163265.84794699,808947.795553841,266,251,2.42488163663107,1.11244611417382 +-135.12633,55.7890135,13.719616,1166969.49406013,808947.683703244,194,251,2.28780172993023,0.614532766535627 +-135.06961,55.7796811,13.719616,1170673.63811266,808947.724954665,196,251,2.29225607135648,0.630712205991387 +-135.01292,55.7703214,13.719616,1174377.68282069,808947.742889578,196,251,2.29225607135648,0.630712205991387 +-134.95626,55.7609343,13.719616,1178081.63561598,808947.72556983,186,151,2.26951294421792,0.548102676689368 +-134.89963,55.75152,13.719616,1181785.49447751,808947.693136016,191,151,2.28103336724773,0.589948141389748 +-134.84302,55.7420783,13.719616,1185489.87155606,808947.801487751,204,151,2.3096301674259,0.693819881976265 +-134.78645,55.7326093,13.719616,1189193.56482431,808947.703631762,207.419143676758,251,2.316848836959,0.720040150133889 +-134.7299,55.7231131,13.719616,1192897.77848934,808947.766603081,201.798492431641,251,2.30491791744566,0.676703645037996 +-134.67338,55.7135897,13.719616,1196601.91520659,808947.810676917,200.209564208984,251,2.30148482031598,0.664233656359525 +-134.61689,55.7040391,13.719616,1200305.97919501,808947.834644346,206.090194702148,251,2.31405732953734,0.709900598402876 +-134.56043,55.6944612,13.719616,1204009.97788336,808947.826635098,204.038955688477,251,2.30971309206022,0.694121087917182 +-134.504,55.6848562,13.719616,1207713.90905752,808947.806797671,215.181076049805,251,2.33280407494731,0.777994128585768 +-134.4476,55.6752241,13.719616,1211417.77689249,808947.773938356,211.530609130859,251,2.32537322000792,0.751003142468736 +-134.39123,55.6655648,13.719616,1215121.5888002,808947.716210591,212.373825073242,251,2.3271009892138,0.75727889337892 +-134.33488,55.6558784,13.719616,1218825.94728907,808947.826630319,212.25407409668,251,2.32685603503248,0.7563891498755 +-134.27857,55.6461649,13.719616,1222529.65337916,808947.73752997,201.698837280273,251,2.30470339467178,0.675924437092359 +-134.22228,55.6364243,13.719616,1226233.91436116,808947.815359887,203.423934936523,251,2.30840205084486,0.689359012014556 +-134.16603,55.6266566,13.719616,1229937.53124387,808947.690237043,214,151,2.33041377334919,0.769311870921396 +-134.1098,55.616862,13.719616,1233641.70473186,808947.752150478,159.407485961914,151,2.20250871251563,0.304724182234876 +-134.0536,55.6070403,13.719616,1237345.84393065,808947.794013879,135.053283691406,151,2.13050514810674,0.0431866844384176 +-133.99743,55.5971916,13.719616,1241049.94966489,808947.825335816,107.844451904297,151,2.03279780758111,-0.311714264802203 +-133.94129,55.5873159,13.719616,1244754.02603204,808947.844983433,91.5296936035156,50,1.96156200855976,-0.570463019569055 +-133.88518,55.5774133,13.719616,1248458.07380066,808947.86246581,77.9591293334961,50,1.89186698016634,-0.82361525563557 +-133.82911,55.5674838,13.719616,1252161.49546102,808947.688109133,114.90111541748,151,2.06032424467876,-0.211730388436165 +-133.77306,55.5575273,13.62421686,1255865.50154604,808947.686702465,147.40364074707,151,2.16850821036724,0.181224653722434 +-133.54915,55.5174326,10.23058659,1270681.99352468,808947.838089194,47.9707794189453,50,1.68097677484691,-1.58962867541317 +-133.43738,55.4972243,8.290297068,1278089.90554854,808947.811969406,36.1004486083984,50,1.55751259877384,-2.03808580309485 +-133.26995,55.4667111,13.42563372,1289201.80710264,808947.785801796,67.9358673095703,50,1.83209912423494,-1.04070916782292 +-133.15848,55.4462353,13.57276232,1296609.80437011,808947.782264591,46.7449226379395,50,1.66973444536732,-1.63046402496334 +-156.33314,57.2303628,13.53298819,-140542.437649256,805243.784264161,29.2755355834961,20,1.46650484905027,-2.36865192628879 +-156.27169,57.2315129,13.719616,-136837.917893781,805243.768283469,143.975967407227,20,2.15829000533501,0.144109216479312 +-156.21025,57.2326323,13.719616,-133134.234603254,805243.779000396,29.3681488037109,20,1.46787657200216,-2.36366943699882 +-156.1488,57.233721,13.719616,-129430.177195517,805243.77521698,32.6017684936523,20,1.51324115915391,-2.19889230812136 +-156.08735,57.234779,13.719616,-125726.341467874,805243.777006581,60.3976058959961,20,1.78101972393959,-1.22624412920797 +-156.02589,57.2358064,13.719616,-122022.118622634,805243.776637318,174.928680419922,121,2.24286102003879,0.451295280854267 +-155.96443,57.236803,13.719616,-118318.105146632,805243.770780655,231.918640136719,220,2.3653356558531,0.896158115873242 +-155.90297,57.237769,13.719616,-114614.294037078,805243.781266994,253.204437255859,220,2.40347131216226,1.03467770458809 +-155.8415,57.2387042,13.719616,-110910.077484222,805243.768606591,231.341842651367,220,2.36425419044081,0.892229924814843 +-155.78003,57.2396088,13.719616,-107206.050651755,805243.772477024,250.499389648438,220,2.39880667202906,1.01773440020346 +-155.71856,57.2404827,13.719616,-103502.20752498,805243.78127764,265.409027099609,220,2.42391569001627,1.10893752036027 +-155.65708,57.2413258,13.719616,-99797.9399203448,805243.768394261,271.18017578125,220,2.43325793791074,1.14287123125602 +-155.59561,57.2421383,13.719616,-96094.4451880557,805243.786347437,277.179779052734,220,2.44276154424375,1.1773910420568 +-155.53412,57.24292,13.719616,-92389.9111577319,805243.769011109,270.278015136719,220,2.43181072089991,1.13761452599582 +-155.47264,57.243671,13.719616,-88686.1375938632,805243.770572365,263.038024902344,220,2.42001853484553,1.09478194042132 +-155.41115,57.2443914,13.719616,-84981.9136676304,805243.774559467,256.157135009766,220,2.40850645723447,1.05296678866385 +-155.34967,57.245081,13.719616,-81278.4377787099,805243.784449104,249.249176025391,220,2.39663373128372,1.00984165919737 +-155.28818,57.2457399,13.719616,-77574.4990867349,805243.786030208,244.992523193359,220,2.38915283054651,0.98266889245817 +-155.22668,57.246368,13.719616,-73870.0914580848,805243.769492338,237.404678344727,220,2.37548927299802,0.933038951474426 +-155.16519,57.2469655,13.719616,-70166.4123832883,805243.779655958,237.869888305664,220,2.37633946864349,0.936127104728787 +-155.10369,57.2475322,13.719616,-66462.2516699221,805243.772216874,232.448837280273,220,2.36632737816366,0.899760334370897 +-155.04219,57.2480683,13.719616,-62758.2047220467,805243.780345353,224.339263916016,220,2.35090529056801,0.843742910321461 +-154.98069,57.2485736,13.719616,-59054.2655585393,805243.781455098,194.93896484375,220,2.28989865556344,0.622149398957633 +-154.91919,57.2490481,13.719616,-55350.4278061202,805243.775298704,150.585632324219,121,2.17778353693788,0.21491528726879 +-154.85768,57.249492,13.719616,-51646.0826759553,805243.776192502,87.5579452514648,22,1.94229556129675,-0.640444255219859 +-154.79618,57.2499051,13.719616,-47942.428377252,805243.777705539,73.1644058227539,22,1.86429984998778,-0.923746940886423 +-154.73467,57.2502875,13.719616,-44238.2541584716,805243.775802705,61.826244354248,22,1.79117286600778,-1.18936501922105 +-154.67316,57.2506392,13.6991009,-40534.155802648,805243.778073879,52.9965667724609,22,1.72424773601456,-1.43245619369033 +-154.61165,57.2509601,12.04460814,-36830.1270685199,805243.773183972,19.4642925262451,22,1.2892386229254,-3.01253345639257 +-152.95084,57.2480091,9.07067601,63177.9911566087,805243.780940824,13.3889179229736,30,1.12674547924718,-3.6027549343926 +-152.88934,57.2474696,13.719616,66882.050551758,805243.782153429,111.585807800293,30,2.04760896175241,-0.257915925327735 +-152.82785,57.2468994,13.719616,70585.6224837703,805243.777173395,87.849250793457,30,1.94373806204469,-0.635204680772631 +-152.76635,57.2462984,13.719616,74289.9177549131,805243.775817135,43.210319519043,30,1.63558747771702,-1.75449555798414 +-152.70486,57.2456668,13.719616,77993.7380480082,805243.7788869,41.2873992919922,30,1.61581752737194,-1.8263056605431 +-152.64337,57.2450044,13.719616,81697.6922552114,805243.774996709,63.3319358825684,30,1.80162276341445,-1.15140800914233 +-152.58188,57.2443113,13.719616,85401.7865089075,805243.775631882,88.1017913818359,30,1.94498473905151,-0.630676394046809 +-152.52039,57.2435875,13.719616,89106.02714827,805243.78113101,82.0662994384766,30,1.91416485051008,-0.742623026101291 +-152.45891,57.242833,13.719616,92809.8183850763,805243.777872607,75.5586853027344,31,1.87828439272869,-0.872951090065566 +-152.39743,57.2420478,13.719616,96513.7686840781,805243.779084803,71.9402465820312,31,1.85697192207065,-0.950364066680312 +-152.33595,57.2412318,13.719616,100217.884662278,805243.773991054,74.5442199707031,31,1.87241397465493,-0.894274124093585 +-152.27448,57.2403852,13.719616,103921.569980443,805243.769661992,78.4890441894531,31,1.89480904043795,-0.81292885298149 +-152.213,57.2395079,13.719616,107626.035497468,805243.786089526,80.5586242675781,31,1.90611204098522,-0.771873128796243 +-152.15153,57.2385998,13.719616,111330.083605632,805243.780688593,80.5,31,1.90579588036787,-0.773021514399693 +-152.09007,57.2376611,13.719616,115033.720028352,805243.774548084,78.7291717529297,31,1.89613568259883,-0.808110109991798 +-152.02861,57.2366917,13.719616,118737.553526447,805243.773172859,76.2130279541016,31,1.88202921654904,-0.859348821070918 +-151.96715,57.2356915,13.719616,122441.590774443,805243.765877901,73.3862533569336,31,1.86561471590586,-0.918970972571862 +-151.90569,57.2346607,13.719616,126145.83743138,805243.775468334,63.3753128051758,31,1.80192011591893,-1.15032793997322 +-151.84424,57.2335992,13.719616,129849.698032968,805243.77173632,57.6797294616699,31,1.76102321472144,-1.29887715826028 +-151.78279,57.232507,13.719616,133553.781036309,805243.77363691,53.486385345459,31,1.72824324890334,-1.41794335044536 +-151.72135,57.2313841,13.719616,137257.49064399,805243.761035265,53.0799522399902,31,1.72493052342529,-1.42997611492761 +-151.6599,57.2302306,13.719616,140962.037044786,805243.786413948,59.153938293457,31,1.77198366396275,-1.25906567819214 +-151.59847,57.2290463,13.719616,144665.620962034,805243.764345509,70.4989318847656,31,1.8481825371323,-0.982289621516617 +-151.53703,57.2278314,13.719616,148370.054305766,805243.781397367,62.6020164489746,31,1.79658832232478,-1.16969453615256 +-151.47561,57.2265859,13.719616,152073.536990131,805243.771137659,80.8160705566406,31,1.90749773033015,-0.766839909580338 +-151.41418,57.2253096,13.719616,155777.88255815,805243.778886302,102.81037902832,134,2.01203696025452,-0.38712358802813 +-151.35276,57.2240027,13.719616,159481.89222084,805243.781220616,135.069488525391,134,2.13055725530178,0.0433759526436694 +-151.29135,57.2226651,13.719616,163185.57272476,805243.765949446,158.06852722168,134,2.19884540684165,0.291418010415474 +-151.22994,57.2212969,13.719616,166889.532052417,805243.768335319,137.382690429688,134,2.13793201711631,0.0701631925206251 +-151.16853,57.219898,13.719616,170593.776968752,805243.777890874,102.463691711426,134,2.01056999921764,-0.392452009226466 +-151.10713,57.2184684,13.719616,174297.71166587,805243.769052867,109.304222106934,134,2.0386369378173,-0.290504877130636 +-151.04573,57.2170082,13.719616,178001.944091856,805243.778800274,155.40397644043,134,2.19146212723222,0.264599831476185 +-150.98434,57.2155174,13.719616,181705.878405482,805243.780482675,271.331970214844,134,2.4335009683649,1.14375398723331 +-150.92296,57.2139959,13.719616,185409.521408135,805243.762000722,378.203369140625,134,2.57772539334209,1.66761826449973 +-150.86157,57.2124438,13.719616,189114.083140054,805243.790525936,390.657928466797,231,2.59179664281285,1.71872905891201 +-150.8002,57.210861,13.719616,192817.764040293,805243.770234043,588.040832519531,231,2.76940748376698,2.36386232843854 +-135.19958,55.7664069,13.719616,1163266.02599347,805243.847759287,534,450,2.72754125702856,2.21179224311377 +-135.14288,55.7571094,13.719616,1166969.93111248,805243.817473923,216,251,2.33445375115093,0.783986223421782 +-135.08621,55.7477846,13.719616,1170673.7288182,805243.761356587,207,251,2.31597034545692,0.716849218251904 +-135.02956,55.7384324,13.719616,1174378.02866264,805243.844285784,199,251,2.29885307640971,0.65467441131743 +-134.97295,55.7290529,13.719616,1178081.62754969,805243.722592289,202,251,2.30535136944662,0.678278066425006 +-134.91636,55.7196462,13.719616,1181785.73084852,805243.759942537,183,151,2.26245108973043,0.522452005536869 +-134.8598,55.7102121,13.719616,1185489.74700824,805243.756886195,202,251,2.30535136944662,0.678278066425006 +-134.80327,55.7007509,13.719616,1189193.67078948,805243.744243826,198,251,2.29666519026153,0.646727384342376 +-134.74677,55.6912623,13.719616,1192897.51595154,805243.688740502,198,251,2.29666519026153,0.646727384342376 +-134.69029,55.6817466,13.719616,1196601.87931635,805243.801376943,199.866165161133,251,2.30073927972329,0.661525640128405 +-134.63385,55.6722037,13.719616,1200305.5640256,805243.710451937,220.170669555664,251,2.34275946314368,0.814154940065662 +-134.57743,55.6626336,13.719616,1204009.77854615,805243.775677731,210.306732177734,251,2.32285317521055,0.741849620472279 +-134.52104,55.6530363,13.719616,1207713.92495885,805243.815673462,207.795928955078,251,2.31763703480122,0.722903109670893 +-134.46468,55.6434119,13.719616,1211418.00423513,805243.839911188,206.509750366211,251,2.31494056170803,0.713108749746401 +-134.40835,55.6337604,13.719616,1215122.0205444,805243.8471983,210.45246887207,251,2.32315402493425,0.74294239253985 +-134.35205,55.6240818,13.719616,1218825.97805047,805243.83634997,234.393661499023,251,2.36994586326236,0.912903705067859 +-134.29578,55.6143761,13.719616,1222529.88091151,805243.806189199,233.589447021484,251,2.36845321856082,0.90748199346864 +-134.23954,55.6046433,13.719616,1226233.7332801,805243.755546722,177.240264892578,151,2.24856239043032,0.47200428544942 +-134.18333,55.5948835,13.719616,1229937.53602765,805243.693910495,163.050201416016,151,2.21232133962655,0.340366444704381 +-134.12714,55.5850967,13.719616,1233641.89539536,805243.805876451,148.800842285156,151,2.17260538953486,0.196106777910607 +-134.07099,55.5752829,13.719616,1237345.6112384,805243.719330449,124.571670532227,151,2.09541928846758,-0.0842551722723918 +-134.01486,55.5654421,13.719616,1241049.89191356,805243.805199935,105.129165649414,151,2.02172321767837,-0.3519403363316 +-133.95877,55.5555744,13.719616,1244753.5339534,805243.699792779,94.0638656616211,50,1.97342282260285,-0.527381157551192 +-133.9027,55.5456797,13.719616,1248457.74899689,805243.765638916,86.2917251586914,50,1.93596915156433,-0.663423581105125 +-133.84666,55.5357581,13.719616,1252161.93567426,805243.82537166,85.0545654296875,50,1.92969762997336,-0.686203537594013 +-133.79066,55.5258095,13.67497803,1255865.49925066,805243.678131267,75.5131683349609,50,1.87802269251042,-0.873901659954973 +-133.73468,55.5158342,7.905157781,1259569.6380135,805243.732338042,14.9980144500732,50,1.17603376769208,-3.42372580248259 +-133.56692,55.4857469,9.446024771,1270681.97300759,805243.833702577,27.9004783630371,50,1.44561164946164,-2.44454199070756 +-133.34367,55.4452554,12.88363825,1285497.72705437,805243.750711035,129.638427734375,50,2.11273375523254,-0.0213640869411975 +-133.23222,55.4248493,8.60254067,1292905.92412644,805243.818023477,18.379264831543,50,1.26432813566872,-3.10301545626978 +-133.17654,55.4146062,13.66693479,1296610.03995277,805243.855192135,146.370910644531,50,2.16545477479725,0.170133704194972 +-133.1209,55.4043365,11.69765079,1300313.56698015,805243.708086418,135.201919555664,50,2.13098285763013,0.0449218617792506 +-133.06528,55.3940401,11.03594863,1304017.71681617,805243.756095717,122.654571533203,50,2.08868373969808,-0.108720607920215 +-156.33098,57.197203,11.80380898,-140542.27903689,801539.78005558,30.1408233642578,20,1.47915511186944,-2.32270256098505 +-156.26959,57.198352,13.719616,-136837.956597429,801539.762584099,24.9917469024658,20,1.39779661401302,-2.6182198472268 +-156.20821,57.1994704,13.719616,-133134.470462772,801539.779537674,46.3099365234375,20,1.66567418571124,-1.64521204694771 +-156.14681,57.2005582,13.719616,-129430.006284888,801539.770231236,62.6042289733887,20,1.79660367119402,-1.1696387846785 +-156.08542,57.2016153,13.719616,-125726.366172537,801539.783118917,87.0473403930664,20,1.93975550640958,-0.649670459573919 +-156.02402,57.2026417,13.719616,-122022.338429458,801539.779264562,163.39599609375,121,2.21324141023988,0.343708403786278 +-155.96261,57.2036375,13.719616,-118317.916397738,801539.770999209,246.760009765625,220,2.39227477875932,0.994008699459811 +-155.90121,57.2046026,13.719616,-114614.299468023,801539.782869473,254.009857177734,220,2.40485057030038,1.03968756382523 +-155.8398,57.205537,13.719616,-110910.275941504,801539.779330384,251.188751220703,220,2.40000018684795,1.02206958668873 +-155.77839,57.2064407,13.719616,-107206.44217218,801539.777742263,261.255187988281,220,2.4170649233959,1.08405358059162 +-155.71697,57.2073138,13.719616,-103502.188855624,801539.773238708,266.414611816406,220,2.42555804053284,1.11490300620995 +-155.65555,57.2081562,13.719616,-99798.1126535294,801539.770935532,271.136199951172,220,2.43318750500023,1.14261539882147 +-155.59413,57.2089679,13.719616,-96094.2072331188,801539.770421802,274.627105712891,220,2.43874339990939,1.16279599494183 +-155.53271,57.209749,13.719616,-92390.4660032976,801539.782461786,269.251647949219,220,2.43015837006867,1.13161271614887 +-155.47128,57.2104994,13.719616,-88686.2802236375,801539.782160525,262.19775390625,220,2.41862896702493,1.08973463347474 +-155.40985,57.211219,13.719616,-84982.2464808513,801539.772460818,255.512451171875,220,2.4074120682417,1.0489916554724 +-155.34842,57.211908,13.719616,-81278.357955266,801539.77533272,249.757858276367,220,2.39751916157219,1.01305779473204 +-155.28698,57.2125663,13.719616,-77574.0058736273,801539.767598627,246.509857177734,220,2.39183429007291,0.992408718822776 +-155.22555,57.213194,13.719616,-73870.3890624435,801539.784018204,236.827880859375,220,2.37443282892337,0.929201645056151 +-155.16411,57.2137909,13.719616,-70166.2962378356,801539.77915857,232.705062866211,220,2.36680583215196,0.901498215820778 +-155.10267,57.2143571,13.719616,-66462.32353039,801539.775570482,229.135787963867,220,2.36009292551151,0.877115022848348 +-155.04123,57.2148927,13.719616,-62758.4644269651,801539.784139498,214.339431762695,220,2.3311020750158,0.771811979035363 +-154.97978,57.2153975,13.719616,-59054.1102647951,801539.773388351,192.287185668945,220,2.2839503431116,0.600543430315135 +-154.91834,57.2158717,13.719616,-55350.459734224,801539.783736794,161.78337097168,121,2.20893388027761,0.328062225471871 +-154.85689,57.2163151,13.719616,-51646.3014457878,801539.775402381,84.2898712158203,22,1.92577539029064,-0.700450231640302 +-154.79544,57.2167279,13.719616,-47942.2314458041,801539.779385454,75.1908569335938,22,1.87616503441215,-0.88064920439632 +-154.73399,57.2171099,13.719616,-44238.2436718221,801539.773159673,69.9436569213867,22,1.84474833514023,-0.994763623370661 +-154.67254,57.2174613,13.719616,-40534.3315262372,801539.778863636,60.9514045715332,22,1.78498371800424,-1.21184577132861 +-154.61109,57.2177819,13.67525005,-36830.4889046459,801539.774000469,22.8918437957764,22,1.35968077380529,-2.75666745820521 +-153.01326,57.2153419,12.6421642,59473.6705955016,801539.778249426,114.272506713867,30,2.05794175429108,-0.220384273554674 +-152.95181,57.2148335,13.719616,63178.0368213222,801539.775487012,125.225952148438,30,2.09769434250761,-0.0759915266339179 +-152.89037,57.2142945,13.719616,66881.9083598606,801539.775693973,41.1312637329102,30,1.61417205314638,-1.83228249259545 +-152.82893,57.2137248,13.719616,70585.8944000459,801539.776926774,103.870765686035,30,2.01649333304563,-0.370936770075401 +-152.76749,57.2131244,13.719616,74290.0012799538,801539.779463447,132.214752197266,30,2.12127991536466,0.00967800597559228 +-152.70606,57.2124933,13.719616,77993.6326526183,801539.771852909,75.0752029418945,30,1.87549651484938,-0.883077458262756 +-152.64462,57.2118315,13.719616,81698.0002241726,801539.777333621,71.9533004760742,30,1.85705071968571,-0.950077851251315 +-152.58319,57.2111391,13.719616,85401.9047239139,801539.783343247,81.0938949584961,30,1.90898816018357,-0.761426242941698 +-152.52176,57.2104159,13.719616,89105.9556382725,801539.779642224,99.6811218261719,30,1.9986129169573,-0.435883544887093 +-152.46034,57.2096621,13.719616,92809.5561314572,801539.774929461,106.47093963623,31,2.02723108685611,-0.331934183375679 +-152.39891,57.2088775,13.719616,96513.9184145098,801539.774644447,76.8523330688477,31,1.88565705626708,-0.846171471726446 +-152.33749,57.2080623,13.719616,100217.842924539,801539.772982283,75.4812469482422,31,1.87783906608573,-0.874568643541641 +-152.27607,57.2072165,13.719616,103921.938648522,801539.784314921,80.4727096557617,31,1.90564862502191,-0.77355638784709 +-152.21466,57.2063399,13.719616,107625.609803793,801539.77052983,81.1605758666992,31,1.90934511986504,-0.760129663492171 +-152.15324,57.2054327,13.719616,111330.067501589,801539.786227423,81.8956451416016,31,1.91326080846058,-0.745906764864341 +-152.09184,57.2044948,13.719616,115033.510309272,801539.77039949,79.344841003418,31,1.89951869420888,-0.795822046216439 +-152.03043,57.2035262,13.719616,118737.7526109,801539.773794679,78.4841918945312,31,1.89478219095759,-0.81302637795777 +-151.96903,57.202527,13.719616,122441.595025706,801539.772842576,70.1966857910156,31,1.8463166081889,-0.989067208028178 +-151.90763,57.2014971,13.719616,126145.646887747,801539.774193298,61.764762878418,31,1.79074077845558,-1.19093448454072 +-151.84623,57.2004365,13.719616,129849.914524988,801539.778349036,59.2006340026855,31,1.77232635777686,-1.25782091644474 +-151.78484,57.1993453,13.719616,133553.801207692,801539.776873559,62.641487121582,31,1.79686205941117,-1.16870024492248 +-151.72345,57.1982234,13.719616,137257.916298228,801539.778135944,62.2032089233398,31,1.79381278954214,-1.17977606343507 +-151.66207,57.1970709,13.719616,140961.663044402,801539.772613561,65.5953598022461,31,1.81687311858975,-1.09601436626092 +-151.60069,57.1958877,13.719616,144665.650827322,801539.769821418,64.9305191040039,31,1.81244887496737,-1.11208448190227 +-151.53931,57.1946739,13.719616,148369.885556772,801539.781491538,73.4809494018555,31,1.86617475892015,-0.916936736491766 +-151.47794,57.1934294,13.719616,152073.771263422,801539.77416041,90.8654556274414,31,1.95839880861511,-0.581952664635171 +-151.41657,57.1921543,13.719616,155777.916518934,801539.781372368,112.367256164551,134,2.05063977619057,-0.246907142207776 +-151.35521,57.1908485,13.719616,159481.72537251,801539.768578923,131.997940063477,134,2.12056715373581,0.00708905229718005 +-151.29385,57.1895122,13.719616,163185.805918306,801539.781622518,156.005355834961,134,2.19313950841627,0.270692558708917 +-151.2325,57.1881451,13.719616,166889.563123134,801539.762561823,135.006423950195,134,2.13035443382646,0.0426392471542848 +-151.17115,57.1867475,13.719616,170593.604593254,801539.769536822,108.638160705566,134,2.03598240419172,-0.30014690093809 +-151.1098,57.1853192,13.719616,174297.937553884,801539.780920709,180.799713134766,134,2.25719773706807,0.503370329211031 +-151.04846,57.1838603,13.719616,178001.965139064,801539.78175783,358.052642822266,134,2.55394688364515,1.58124793021809 +-150.98713,57.1823708,13.719616,181705.693631213,801539.771083866,539.795715332031,231,2.73222943298997,2.22882103634426 +-150.9258,57.1808507,13.719616,185409.73199606,801539.775867797,691.318420410156,231,2.83967812895809,2.61910536901167 +-135.15941,55.7252016,13.719616,1166969.8730447,801539.803686036,502,450,2.70070371714502,2.11431063806025 +-135.10278,55.7158843,13.719616,1170673.92542983,801539.81578223,210,351,2.32221929473392,0.739547185653671 +-135.04618,55.7065397,13.719616,1174377.87092254,801539.798123201,203,251,2.30749603791321,0.686068114444982 +-134.98961,55.6971678,13.719616,1178081.71380212,801539.749446659,190,251,2.27875360095283,0.581667379496592 +-134.93306,55.6877687,13.719616,1181786.05787136,801539.857135737,193,251,2.28555730900777,0.60638038912377 +-134.87655,55.6783423,13.719616,1185489.70516677,801539.75390906,191,251,2.28103336724773,0.589948141389748 +-134.82006,55.6688886,13.719616,1189193.86532004,801539.794986783,201,251,2.30319605742049,0.670449357958785 +-134.7636,55.6594078,13.719616,1192897.93353837,801539.822546069,195,251,2.29003461136252,0.622643229225523 +-134.70717,55.6498997,13.719616,1196601.92040234,801539.813996506,199,251,2.29885307640971,0.65467441131743 +-134.65077,55.6403645,13.719616,1200305.8237564,801539.789470079,199,251,2.29885307640971,0.65467441131743 +-134.5944,55.6308021,13.719616,1204009.65099636,801539.737073754,215.132247924805,251,2.33270551520417,0.777636131466935 +-134.53805,55.6212125,13.719616,1207714.00901434,801539.837455342,229.352935791016,251,2.36050430361201,0.878609265528359 +-134.48174,55.6115959,13.719616,1211417.6901878,801539.747593916,238.382705688477,251,2.37727474479091,0.939524294650602 +-134.42545,55.6019521,13.719616,1215121.91050161,801539.809225055,243.148162841797,251,2.38587099251129,0.970748319984417 +-134.36919,55.5922813,13.719616,1218826.06497059,801539.860628587,206.708282470703,251,2.31535787846211,0.714624563311288 +-134.31297,55.5825834,13.719616,1222529.5582961,801539.705871124,189.121475219727,151,2.27674084687718,0.574356482196615 +-134.25677,55.5728584,13.719616,1226233.59999978,801539.711389493,166.063659667969,151,2.22027460456213,0.369254973038211 +-134.2006,55.5631065,13.719616,1229937.58499881,801539.713787548,148.836502075195,151,2.17270945477,0.196484772547816 +-134.14446,55.5533275,13.719616,1233641.52394389,801539.690593394,137.467254638672,151,2.13819925945087,0.0711338929583131 +-134.08834,55.5435216,13.719616,1237346.0170742,801539.848258342,118.319496154785,151,2.07305631161711,-0.165483887222363 +-134.03226,55.5336887,13.719616,1241049.86639653,801539.802903763,100.102561950684,50,2.00044519263223,-0.429228196652177 +-133.97621,55.5238288,13.719616,1244753.67869299,801539.73914169,88.7381362915039,50,1.94811030327601,-0.619323452658572 +-133.92018,55.513942,13.719616,1248458.05742277,801539.854457896,90.0072021484375,50,1.95427726197465,-0.596923298439859 +-133.86419,55.5040284,13.719616,1252161.79795006,801539.782923257,67.3353118896484,50,1.82824287606556,-1.05471616185693 +-133.80823,55.4940878,13.719616,1255865.51365694,801539.689569339,47.0130844116211,50,1.67221874510452,-1.62144033922807 +-133.64051,55.464105,6.876721989,1266977.72432748,801539.755225476,15.2267684936523,50,1.18260774481433,-3.39984724117471 +-133.47306,55.433881,7.954860452,1278089.79644853,801539.782284167,18.1776332855225,50,1.25953733774471,-3.12041700175964 +-133.36158,55.4135978,13.719616,1285497.6153856,801539.713841942,107.29337310791,50,2.03057289893199,-0.319795768067957 +-133.25021,55.3932079,12.74589296,1292906.03802828,801539.853349213,181.232757568359,50,2.25823669855822,0.507144133892409 +-133.02785,55.3521083,8.126781266,1307721.79645529,801539.782465145,80.0032730102539,50,1.90310775475714,-0.782785553885299 +-156.32883,57.164042,10.72323578,-140542.483231978,797835.782533545,29.8466129302979,20,1.47489505341702,-2.33817630922601 +-156.2675,57.1651901,13.719616,-136838.364018734,797835.785519271,35.2040405273438,20,1.54659251228562,-2.07775067412307 +-156.20617,57.1663075,13.719616,-133134.478491668,797835.788293156,43.1448249816895,20,1.63492871159983,-1.75688838455236 +-156.14483,57.1673942,13.719616,-129430.217086363,797835.770821867,80.2008361816406,20,1.90417889630386,-0.77889486205339 +-156.08349,57.1684504,13.719616,-125726.176021726,797835.775495516,108.099067687988,20,2.03382194835009,-0.307994293210376 +-156.02215,57.1694759,13.719616,-122022.349715302,797835.779486619,167.748733520508,121,2.22465924999077,0.38518125673744 +-155.9608,57.1704708,13.719616,-118318.128270436,797835.775637591,259.533172607422,220,2.41419287570898,1.0736214836287 +-155.89945,57.171435,13.719616,-114614.108953863,797835.771238127,265.525177001953,220,2.42410570701678,1.10962771634238 +-155.8381,57.1723686,13.719616,-110910.285130143,797835.776977089,263.240936279297,220,2.42035342680281,1.09599836359784 +-155.77674,57.1732716,13.719616,-107206.047260613,797835.776257763,268.710388183594,220,2.42928445632377,1.12843841198757 +-155.71538,57.1741439,13.719616,-103501.992578696,797835.774740299,268.833831787109,220,2.42948392224595,1.12916292915018 +-155.65402,57.1749855,13.719616,-99798.1147555554,797835.771999728,274.522705078125,220,2.438578269669,1.16219619477588 +-155.59266,57.1757965,13.719616,-96094.4071939606,797835.778785593,272.466827392578,220,2.43531363484268,1.15033810926715 +-155.53129,57.1765769,13.719616,-92390.2603523223,797835.780791622,266.236083984375,220,2.42526691670316,1.11384556136555 +-155.46992,57.1773266,13.719616,-88686.2714199908,797835.781505504,260.586791992188,220,2.4159523994415,1.08001257604328 +-155.40855,57.1780456,13.719616,-84982.4340654036,797835.780561908,255.831802368164,220,2.40795453050429,1.05096203324428 +-155.34717,57.178734,13.719616,-81278.1384876829,797835.776532285,251.496276855469,220,2.40053156015499,1.02399968620894 +-155.28579,57.1793917,13.719616,-77573.981843384,797835.771275166,246.138870239258,220,2.39118020288369,0.990032887456467 +-155.22441,57.1800188,13.719616,-73869.9575933746,797835.775630932,236.442535400391,220,2.37372560769129,0.926632815680221 +-155.16303,57.1806152,13.719616,-70166.0596302038,797835.778133341,230.219024658203,220,2.36214120966163,0.884554975520101 +-155.10165,57.1811809,13.719616,-66462.2816194805,797835.77849167,222.741256713867,220,2.34780066563621,0.832466026420973 +-155.04026,57.181716,13.719616,-62758.0138091944,797835.778141703,209.524948120117,220,2.32123574179312,0.735974640638731 +-154.97888,57.1822204,13.719616,-59054.4565440375,797835.785119056,196.125717163086,220,2.29253454466077,0.631723700516794 +-154.91749,57.1826941,13.719616,-55350.3970036716,797835.780835635,152.718444824219,121,2.1838914928627,0.237101126571915 +-154.8561,57.1831371,13.719616,-51646.4320941824,797835.774510425,91.0440979003906,22,1.95925179711201,-0.578854366947303 +-154.7947,57.1835495,13.719616,-47941.9521031283,797835.76987055,77.5048828125,22,1.88932906394793,-0.832833691734264 +-154.73331,57.1839312,13.719616,-44238.157332339,797835.770548811,72.3353805541992,22,1.85935077061472,-0.941723409777257 +-154.67192,57.1842823,13.719616,-40534.4380893214,797835.779744733,61.5590972900391,22,1.78929224265994,-1.19619598000375 +-154.61052,57.1846027,13.719616,-36830.1849277946,797835.780579161,22.2386798858643,22,1.34710900344506,-2.80233171649409 +-154.54912,57.1848924,10.57740004,-33125.9947521636,797835.779557165,16.3778057098389,22,1.21425571476598,-3.28489278108035 +-153.32113,57.1842441,10.76306344,40953.7348373223,797835.779645775,30.2087459564209,30,1.48013269695449,-2.31915169292561 +-153.13695,57.1830885,11.61620408,52065.7556938786,797835.776592498,123.945892333984,30,2.09323213847581,-0.0921995253172512 +-153.01417,57.1821648,9.837055589,59473.80173003,797835.781287472,20.0032176971436,30,1.30109986144965,-2.96945005253796 +-152.8914,57.1811183,13.17369527,66881.6512811279,797835.768791964,32.9930534362793,30,1.51842251042748,-2.18007216139087 +-152.83001,57.1805491,13.719616,70586.0458541743,797835.776141604,39.9729080200195,30,1.60176574423477,-1.87734574767551 +-152.76863,57.1799493,13.719616,74289.9576526098,797835.782469507,141.160446166992,30,2.14971302236827,0.112955166229428 +-152.70725,57.1793187,13.719616,77993.9966566675,797835.775816876,141.518218994141,30,2.15081235434285,0.116948253741681 +-152.64588,57.1786575,13.719616,81697.5655336343,797835.76651093,82.2834396362305,30,1.91531243790615,-0.738454661124687 +-152.5845,57.1779657,13.719616,85401.877070402,797835.778919251,98.6983795166016,130,1.99431002224638,-0.451512886645557 +-152.52313,57.1772432,13.719616,89105.7313323968,797835.777056864,94.7400588989258,130,1.97653365038846,-0.516081743115201 +-152.46176,57.17649,13.719616,92809.7378940117,797835.773577722,137.736633300781,130,2.13904946331053,0.0742220760489401 +-152.40039,57.1757062,13.719616,96513.902817883,797835.780008494,91.7302474975586,31,1.96251256527996,-0.567010326245394 +-152.33903,57.1748917,13.719616,100217.629440801,797835.770480497,80.0685577392578,31,1.90346200570808,-0.78149881331819 +-152.27767,57.1740466,13.719616,103921.527045747,797835.770524738,80.5323867797852,31,1.9059705706922,-0.77238698928015 +-152.21631,57.1731708,13.719616,107625.602231035,797835.769393368,81.0717926025391,31,1.90886977593801,-0.761856248311792 +-152.15495,57.1722644,13.719616,111329.861015326,797835.778671581,82.1287460327148,31,1.91449519193446,-0.741423131759096 +-152.0936,57.1713273,13.719616,115033.706773815,797835.770320415,80.5763931274414,31,1.90620782299393,-0.77152522120171 +-152.03225,57.1703596,13.719616,118737.748745299,797835.772160228,76.4529037475586,31,1.88339398494249,-0.854391592722216 +-151.9709,57.1693613,13.719616,122441.993225276,797835.784661448,68.7194747924805,31,1.83707983162064,-1.02261781696264 +-151.90956,57.1683323,13.719616,126145.843617467,797835.778157428,67.7316055297852,31,1.83079137037178,-1.04545930312402 +-151.84822,57.1672727,13.719616,129849.909127273,797835.782185401,70.4690856933594,31,1.84799863674624,-0.982957600209177 +-151.78689,57.1661824,13.719616,133553.593177296,797835.765993638,77.9911804199219,31,1.89204549356836,-0.822966844006653 +-151.72556,57.1650616,13.719616,137257.504568323,797835.771420079,79.594352722168,31,1.90088225531802,-0.790869203068976 +-151.66423,57.16391,13.719616,140961.650738157,797835.765540861,75.8138122558594,31,1.87974833544786,-0.867633632258662 +-151.6029,57.1627279,13.719616,144666.036830302,797835.782383986,75.374267578125,31,1.87722310507094,-0.876805989760159 +-151.54158,57.1615152,13.719616,148370.066273906,797835.789026458,93.4435043334961,31,1.97054911705602,-0.5378192763345 +-151.48027,57.1602718,13.719616,152073.745780597,797835.773229542,108.861808776855,134,2.03687554599503,-0.296902754980414 +-151.41896,57.1589978,13.719616,155777.684476989,797835.768536013,120.061622619629,134,2.07940420850169,-0.142426513867416 +-151.35765,57.1576932,13.719616,159481.888649202,797835.775564606,131.80110168457,134,2.11991904040617,0.00473491969398259 +-151.29635,57.156358,13.719616,163185.76134,797835.770376794,141.192245483398,134,2.14981084518427,0.113310486618569 +-151.23505,57.1549922,13.719616,166889.912075592,797835.777077528,119.759414672852,134,2.07830966471499,-0.14640220931461 +-151.17376,57.1535958,13.719616,170593.74389651,797835.770642369,151.591094970703,134,2.18067368995913,0.225413147973747 +-151.11247,57.1521688,13.719616,174297.866326681,797835.776321311,301.107818603516,231,2.47872203260435,1.30800979992776 +-151.05119,57.1507112,13.719616,178001.682404305,797835.768003997,501.083312988281,330,2.69990994016459,2.11142741350083 +-135.11933,55.6839803,13.719616,1170673.62604957,797835.72403546,494,450,2.69372694892365,2.08896902451232 +-135.06277,55.6746433,13.719616,1174377.81564588,797835.782624323,209,351,2.32014628611105,0.732017426639857 +-135.00624,55.665279,13.719616,1178081.89884798,797835.807522625,202,251,2.30535136944662,0.678278066425006 +-134.94974,55.6558874,13.719616,1181785.87992945,797835.797469527,201,251,2.30319605742049,0.670449357958785 +-134.89327,55.6464686,13.719616,1185489.75999658,797835.761896946,212,251,2.32633586092875,0.754499729058273 +-134.83683,55.6370226,13.719616,1189193.54328472,797835.699551772,212,251,2.32633586092875,0.754499729058273 +-134.78041,55.6275494,13.719616,1192897.83726592,797835.788812297,215,251,2.33243845991561,0.776666110433694 +-134.72402,55.618049,13.719616,1196602.04292213,797835.84993357,215,251,2.33243845991561,0.776666110433694 +-134.66767,55.6085214,13.719616,1200305.56122972,797835.700947644,227.203872680664,251,2.35641572963365,0.863758397843765 +-134.61134,55.5989667,13.719616,1204009.59967948,797835.712223738,250.91975402832,251,2.3995348531352,1.02037936182455 +-134.55504,55.5893849,13.719616,1207713.55920959,797835.702358952,258.258758544922,251,2.41205505903281,1.06585632326722 +-134.49876,55.579776,13.719616,1211418.04723725,797835.852551414,249.018142700195,251,2.396230989616,1.00837878650627 +-134.44252,55.57014,13.719616,1215121.86144725,797835.797328599,199.901214599609,251,2.30081543289904,0.661802250198977 +-134.38631,55.5604769,13.719616,1218825.60924559,797835.717346574,192.409408569336,151,2.28422630465523,0.601545801408871 +-134.33012,55.5507868,13.719616,1222529.89478093,797835.806156118,187.440948486328,151,2.27286447320594,0.560276386595473 +-134.27397,55.5410697,13.719616,1226233.51569435,797835.694952975,164.518936157227,151,2.21621589253091,0.354512572469092 +-134.21784,55.5313255,13.719616,1229937.6858602,797835.740631466,141.80534362793,151,2.15169259660443,0.120145544881914 +-134.16174,55.5215544,13.719616,1233641.79962018,797835.77923361,130.255401611328,151,2.11479574226984,-0.013874361472031 +-134.10567,55.5117563,13.719616,1237345.86434395,797835.79893783,111.38330078125,151,2.04682008381628,-0.260781355159936 +-134.04963,55.5019312,13.719616,1241049.88413476,797835.798583331,97.8730087280273,151,1.99066293923226,-0.464760133133964 +-133.99362,55.4920793,13.719616,1244753.85647932,797835.798293968,98.0484313964844,50,1.99144065010681,-0.461935265256835 +-133.93764,55.4822004,13.719616,1248457.79204489,797835.775635259,95.6954727172852,50,1.98089139210903,-0.500253181362761 +-133.88169,55.4722946,13.719616,1252161.69159457,797835.740101719,82.3553924560547,50,1.9156920411164,-0.737075833915537 +-133.82577,55.462362,12.53627758,1255865.55585017,797835.701183579,65.9130706787109,50,1.81897154449946,-1.08839228440647 +-133.76987,55.4524025,12.16817326,1259569.99541681,797835.836775853,48.5664215087891,50,1.68633610478577,-1.57016205937017 +-133.71401,55.4424162,12.8248891,1263273.80450272,797835.777610102,57.5062980651855,50,1.75971541104044,-1.303627474514 +-133.65818,55.4324031,9.725462526,1266977.59036066,797835.711665147,67.0167617797852,50,1.82618343908942,-1.06219662477608 +-133.37946,55.3819361,13.719616,1285497.50067347,797835.681512867,224.890960693359,50,2.35197199967801,0.847617502278084 +-133.3238,55.3717626,13.719616,1289201.82061899,797835.789289496,90.7003707885742,50,1.9576090624857,-0.58482124799318 +-156.38794,57.1297023,10.44983949,-144245.991678896,794131.767690379,31.9125080108643,20,1.50396093683146,-2.23260072443567 +-156.32668,57.1308799,13.719616,-140542.447681487,794131.782671984,59.1630821228027,20,1.77205079064702,-1.25882185491504 +-156.2654,57.1320269,13.719616,-136837.935340841,794131.763390347,63.542106628418,20,1.80306160901066,-1.14618171124948 +-156.20413,57.1331433,13.719616,-133134.259769901,794131.772776194,63.8617630004883,20,1.80524090372449,-1.13826589081624 +-156.14285,57.1342292,13.719616,-129430.206720478,794131.780792507,89.0003967285156,20,1.949391942562,-0.614668172955583 +-156.08157,57.1352844,13.719616,-125726.374434125,794131.785204198,94.3490905761719,20,1.97473771838909,-0.52260508074693 +-156.02028,57.136309,13.719616,-122022.152450561,794131.778281423,185.938186645508,121,2.26936859120457,0.547578345342429 +-155.95899,57.137303,13.719616,-118318.138279059,794131.779016011,265.580230712891,220,2.42419574384415,1.10995475579845 +-155.8977,57.1382663,13.719616,-114614.325946967,794131.775767495,253.508346557617,220,2.4039922626999,1.03656994563488 +-155.8364,57.1391991,13.719616,-110910.104713726,794131.773682905,276.513549804688,220,2.44171641759813,1.17359484377107 +-155.7751,57.1401012,13.719616,-107206.072713706,794131.767809334,275.211791992188,220,2.43966703816603,1.16615091272254 +-155.7138,57.1409728,13.719616,-103502.223045993,794131.780025242,277.915954589844,220,2.44391347945617,1.18157519954335 +-155.65249,57.1418137,13.719616,-99797.9462022248,794131.772562837,274.918334960938,220,2.43920370494651,1.16446795422081 +-155.59119,57.142624,13.719616,-96094.4431886816,794131.786784547,269.570343017578,220,2.43067211125986,1.13347877079159 +-155.52988,57.1434036,13.719616,-92390.5003663464,794131.781640309,267.540924072266,220,2.42739022276612,1.12155801503809 +-155.46856,57.1441526,13.719616,-88686.1111607172,794131.769583599,258.547088623047,220,2.41253965175008,1.06761650233286 +-155.40725,57.144871,13.719616,-84982.4768744064,794131.777516564,254.975479125977,220,2.40649841654246,1.04567301171859 +-155.34593,57.1455588,13.719616,-81278.3836093515,794131.77893962,250.01774597168,220,2.39797083548825,1.01469840331576 +-155.28461,57.1462159,13.719616,-77574.4290828529,794131.775712335,247.12873840332,220,2.39292325209675,0.996364139714094 +-155.22328,57.1468424,13.719616,-73870.0029591987,794131.767552213,238.179275512695,220,2.37690396990057,0.938177534419189 +-155.16196,57.1474383,13.719616,-70166.3065386997,794131.776958904,230.942153930664,220,2.36350321203613,0.88950215689844 +-155.10063,57.1480035,13.719616,-66462.1261060761,794131.770793266,218.368713378906,220,2.33919041525876,0.801191139439941 +-155.0393,57.1485381,13.719616,-62758.0589550265,794131.771064383,209.326522827148,220,2.32082425933583,0.734480018905057 +-154.97797,57.1490421,13.719616,-59054.0987843669,794131.777512462,199.155700683594,220,2.29919274227934,0.655908174706214 +-154.91664,57.1495154,13.719616,-55350.239446551,794131.778731077,126.833999633789,121,2.10323568788378,-0.0558637785702201 +-154.85531,57.149958,13.719616,-51646.4746086288,794131.774489748,84.8187789916992,22,1.92849201628469,-0.690582670627661 +-154.79397,57.1503701,13.719616,-47942.1938703508,794131.779677372,76.8000030517578,22,1.88536123728882,-0.847245970690605 +-154.73263,57.1507514,13.719616,-44237.9951293127,794131.76894296,71.9543304443359,22,1.85705693630577,-0.950055270712855 +-154.6713,57.1511022,13.719616,-40534.4754820807,794131.781689863,61.452278137207,22,1.78853798753295,-1.19893564991082 +-154.60996,57.1514223,13.719616,-36830.4212611912,794131.782658956,28.2905406951904,22,1.45164124787034,-2.42264076826844 +-154.54862,57.1517117,12.35461187,-33126.4299320415,794131.778355598,19.3734111785889,22,1.28720609596983,-3.01991617443617 +-153.3831,57.1513875,10.75902084,37249.4943523469,794131.768955228,30.2789630889893,30,1.48114099855456,-2.31548925371622 +-153.19908,57.1503249,3.378916359,48361.8954638011,794131.773742306,38.3933944702148,30,1.58425651103671,-1.94094428028356 +-152.83109,57.1473723,13.719616,70586.0768290476,794131.775791926,94.6033248901367,30,1.97590640020797,-0.518360094805773 +-152.76977,57.146773,13.719616,74289.7870616472,794131.774648983,143.662857055664,30,2.15734449909555,0.140674867943225 +-152.70845,57.146143,13.719616,77993.6241144368,794131.768265056,146.508102416992,30,2.1658616433774,0.171611567009934 +-152.64713,57.1454824,13.719616,81697.5940906161,794131.768107022,103.758758544922,30,2.01602476685093,-0.372638736236652 +-152.58581,57.1447912,13.719616,85401.7032893047,794131.774495873,109.687927246094,130,2.04015882977222,-0.284976931159181 +-152.52449,57.1440693,13.719616,89105.9582570474,794131.776607735,115.47730255127,130,2.06249663058813,-0.203839662752653 +-152.46318,57.1433168,13.719616,92809.7612644105,794131.771978435,151.793090820312,130,2.18125200418857,0.227513750322404 +-152.40187,57.1425337,13.719616,96513.7224087535,794131.773833138,123.247077941895,130,2.09077663140765,-0.101118627860312 +-152.34056,57.14172,13.719616,100217.847986781,794131.782552249,74.7539825439453,31,1.87363433479963,-0.889841427722581 +-152.27926,57.1408756,13.719616,103921.540783708,794131.77172408,79.374885559082,31,1.8996831121445,-0.795224833344708 +-152.21795,57.1400006,13.719616,107626.014426307,794131.783656777,83.1070556640625,31,1.91963789629783,-0.72274336163737 +-152.15665,57.139095,13.719616,111330.067609173,794131.786921039,80.6853790283203,31,1.90679484348776,-0.769392995215796 +-152.09536,57.1381587,13.719616,115033.706946271,794131.769125619,82.6331939697266,31,1.91715453959681,-0.731763621996056 +-152.03407,57.1371919,13.719616,118737.541900837,794131.769247122,78.0945510864258,31,1.8926207327806,-0.820877410998185 +-151.97278,57.1361944,13.719616,122441.579415656,794131.765439693,74.6106414794922,31,1.87280077393687,-0.892869158698061 +-151.91149,57.1351664,13.719616,126145.825111146,794131.780502308,76.2359161376953,31,1.88215962364329,-0.858875145282712 +-151.85021,57.1341077,13.719616,129849.682169588,794131.773067612,74.4247360229492,31,1.87171730292266,-0.896804634675091 +-151.78893,57.1330184,13.719616,133553.760340086,794131.773243683,80.3500671386719,31,1.90498624398602,-0.775962344831812 +-151.72765,57.1318985,13.719616,137258.065911501,794131.781559279,81.1169662475586,31,1.90911169979766,-0.760977511801584 +-151.66638,57.1307481,13.719616,140962.000979616,794131.78848771,81.6251068115234,31,1.91182376258481,-0.751126525658872 +-151.60512,57.129567,13.719616,144665.572605438,794131.770602889,99.3657913208008,31,1.9972368954872,-0.440881647622105 +-151.54385,57.1283553,13.719616,148369.994293154,794131.782642791,123.781173706055,134,2.09265459640209,-0.0942973229759331 +-151.48259,57.127113,13.719616,152074.064727758,794131.781070849,136.943664550781,134,2.13654194521152,0.065114054596402 +-151.42134,57.1258402,13.719616,155777.789759933,794131.775970392,143.156967163086,134,2.15581248911523,0.135110170415512 +-151.36009,57.1245368,13.719616,159481.779885375,794131.779145394,167.12614440918,134,2.22304439414522,0.379315639380675 +-151.29884,57.1232028,13.719616,163186.041385957,794131.791228087,194.600204467773,134,2.28914329224877,0.619405703796596 +-151.2376,57.1218382,13.719616,166889.976742435,794131.787735663,170.703125,134,2.23224147165857,0.412722050016427 +-151.17637,57.120443,13.719616,170593.592234446,794131.767656691,261.346710205078,231,2.4172170376315,1.08460610291303 +-151.11514,57.1190173,13.719616,174297.497455766,794131.767391452,362.688507080078,330,2.55953379381924,1.60154118263331 +-151.05391,57.117561,13.719616,178001.699147878,794131.776478621,565.517761230469,330,2.75244624937333,2.30225428390251 +-135.07933,55.6427432,13.719616,1174377.86731109,794131.799173997,303,450,2.4814426285023,1.31789178076452 +-135.02285,55.6333864,13.719616,1178081.58650476,794131.710123898,209,251,2.32014628611105,0.732017426639857 +-134.96639,55.6240025,13.719616,1181785.79731635,794131.781657206,208,251,2.31806333496276,0.724451553535809 +-134.90996,55.6145913,13.719616,1185489.90647726,794131.814293104,225,251,2.35218251811136,0.848382165315956 +-134.85356,55.6051529,13.719616,1189193.91508187,794131.817462361,216,251,2.33445375115093,0.783986223421782 +-134.79719,55.5956873,13.719616,1192897.82735983,794131.789913253,234.387069702148,251,2.36993364953079,0.912859341308639 +-134.74085,55.5861945,13.719616,1196601.64753523,794131.730402006,252.634826660156,251,2.40249321947252,1.03112499276351 +-134.68453,55.5766746,13.719616,1200305.98043165,794131.82910533,275.55810546875,251,2.44021319020663,1.16813469282133 +-134.62825,55.5671276,13.719616,1204009.622635,794131.723866855,277,251,2.44247976906445,1.17636755417894 +-134.57199,55.5575535,13.719616,1207713.78592573,794131.775493532,263,251,2.41995574848976,1.09455388245613 +-134.51576,55.5479523,13.719616,1211417.87067867,794131.802025862,200,251,2.30102999566398,0.662581603403571 +-134.45956,55.538324,13.719616,1215121.88106311,794131.802251034,195.645355224609,151,2.29146954186478,0.627855306379669 +-134.40339,55.5286687,13.719616,1218825.81800281,794131.785623331,195.411468505859,151,2.29095004844443,0.625968357998779 +-134.34725,55.5189863,13.719616,1222529.68887789,794131.74028047,185.203460693359,151,2.26764909760503,0.541332653796565 +-134.29114,55.509277,13.719616,1226233.49132517,794131.686339975,163.254058837891,151,2.21286398755193,0.34233749685648 +-134.23505,55.4995406,13.719616,1229937.83977148,794131.78650223,136.053405761719,151,2.13370941774391,0.0548255063502386 +-134.179,55.4897773,13.719616,1233641.52420661,794131.691044786,123.629920959473,151,2.09212359158611,-0.0962260840314239 +-134.12297,55.4799871,13.719616,1237345.75631267,794131.769742986,107.313766479492,151,2.03065543792663,-0.319495962880448 +-134.06697,55.4701699,13.719616,1241049.93965978,794131.825577925,104.695053100586,151,2.01992616150813,-0.358467757272828 +-134.011,55.4603258,13.719616,1244754.07504309,794131.86802855,104.008422851562,151,2.01706851093181,-0.368847559820698 +-133.95507,55.4504548,13.719616,1248457.56272792,794131.707944179,100.610404968262,50,2.00264289708798,-0.421245506781604 +-133.89916,55.4405569,13.719616,1252161.61437404,794131.719592283,90.1522979736328,50,1.95497680132518,-0.594382371850317 +-133.84328,55.4306322,13.45331679,1255865.6269063,794131.725025022,80.0732955932617,50,1.90348770322322,-0.781405472608388 +-133.78743,55.4206806,13.719616,1259569.60768468,794131.712467582,72.5924987792969,50,1.86089174594707,-0.936126147532027 +-133.73161,55.4107023,13.719616,1263273.55405801,794131.702037001,67.3561706542969,50,1.82837738860172,-1.05422757393187 +-133.67581,55.4006971,13.67883501,1266978.08052214,794131.862127153,39.9780921936035,50,1.6018220651808,-1.87714117392394 +-133.50862,55.3705211,5.426072548,1278089.7127224,794131.745185144,43.0859069824219,50,1.63433523951938,-1.75904404454234 +-133.45295,55.360409,13.20503804,1281793.55698161,794131.697167386,232.345642089844,50,2.36613453119801,0.899059859147648 +-133.3973,55.3502702,12.30339047,1285497.99450912,794131.838119598,31.6122741699219,50,1.49985573987379,-2.2475119715258 +-133.28611,55.3299126,9.758502996,1292905.64274705,794131.72642947,125.414436340332,50,2.09834753061022,-0.0736189610068128 +-156.38574,57.0965401,13.70442166,-144246.102844216,790427.7750564,172.099472045898,20,2.23577953803294,0.425573316952802 +-156.32453,57.0977166,13.719616,-140542.172742118,790427.7702934,43.4198265075684,20,1.6376880838131,-1.74686555707051 +-156.26332,57.0988626,13.719616,-136838.481167932,790427.781301851,93.8054656982422,20,1.97222814385274,-0.531720571766843 +-156.2021,57.0999781,13.719616,-133134.417510835,790427.787480306,63.0900535583496,20,1.79996089608701,-1.15744438561978 +-156.14087,57.1010629,13.719616,-129429.976236338,790427.767649923,66.1628341674805,20,1.82061410048848,-1.0824260522222 +-156.07965,57.1021172,13.719616,-125726.359044354,790427.783132963,80.9022064208984,121,1.90796036615311,-0.765159484221935 +-156.01842,57.1031409,13.719616,-122022.35130275,790427.783841601,197.88069152832,121,2.29640341941202,0.645776557900106 +-155.95718,57.104134,13.719616,-118317.946723982,790427.770952633,253.256652832031,220,2.40356086272053,1.03500297777602 +-155.89595,57.1050965,13.719616,-114614.34773517,790427.780174234,238.69123840332,220,2.37783647772931,0.941564669017409 +-155.83471,57.1060284,13.719616,-110910.339331601,790427.775965254,283.784088134766,220,2.45298804077262,1.21453659638238 +-155.77346,57.1069298,13.719616,-107205.914925241,790427.770704939,282.427459716797,220,2.45090691980084,1.20697737100182 +-155.71222,57.1078005,13.719616,-103502.277547206,790427.774483591,281.543914794922,220,2.4495461450688,1.20203464877126 +-155.65097,57.1086407,13.719616,-99798.2116046966,790427.777467303,276.165069580078,220,2.44116874648024,1.17160554594999 +-155.58972,57.1094502,13.719616,-96094.3157284577,790427.77307433,274.091400146484,220,2.43789540939021,1.1597158513356 +-155.52846,57.1102292,13.719616,-92389.9787232029,790427.769317504,265.115539550781,220,2.42343518432821,1.10719218655125 +-155.46721,57.1109776,13.719616,-88686.4032883312,790427.783041699,260.754730224609,220,2.41623219549478,1.08102887517055 +-155.40595,57.1116953,13.719616,-84982.374650412,790427.775458159,255.675918579102,220,2.40768982493395,1.0500005470583 +-155.34469,57.1123825,13.719616,-81278.4903895103,790427.782449419,253.662094116211,220,2.40425557346485,1.03752636548958 +-155.28342,57.113039,13.719616,-77574.140314741,790427.769681628,248.372268676758,220,2.39510310425422,1.00428198494176 +-155.22215,57.113665,13.719616,-73869.9220461927,790427.771952421,241.816955566406,220,2.38348674917471,0.962088067655148 +-155.16089,57.1142603,13.719616,-70166.4340662166,790427.777203134,232.158996582031,220,2.36578551802686,0.897792143691769 +-155.09962,57.114825,13.719616,-66462.4611465846,790427.77461625,221.924270629883,220,2.34620480121455,0.826669391336459 +-155.03834,57.1153592,13.719616,-62757.996815279,790427.776751618,208.994857788086,220,2.32013560064822,0.731978613988902 +-154.97707,57.1158627,13.719616,-59054.2438491656,790427.780486253,188.739761352539,121,2.27586340157964,0.57116935042812 +-154.91579,57.1163356,13.719616,-55349.9870495306,790427.778394154,121.237243652344,121,2.083636054055,-0.127055242928833 +-154.85452,57.1167778,13.719616,-51646.4289766926,790427.776311209,79.895866394043,22,1.90252431061942,-0.784904789525032 +-154.79324,57.1171895,13.719616,-47942.3543184134,790427.780233793,75.2393417358398,22,1.87644498728048,-0.879632335672027 +-154.73196,57.1175705,13.719616,-44238.361409843,790427.775973937,71.7498168945312,22,1.85582079708831,-0.954545281179935 +-154.67068,57.1179209,13.719616,-40534.4438074838,790427.77450789,52.7024040222168,22,1.72183042602413,-1.44123655354452 +-154.60939,57.1182407,13.719616,-36829.9908533896,790427.770119719,35.708610534668,22,1.55277295159669,-2.05530155447227 +-154.54811,57.1185299,12.71370879,-33126.204962609,790427.774303465,13.8379878997803,22,1.14107294651166,-3.55071348382172 +-153.81266,57.1196115,8.771803986,11322.0681835529,790427.772905695,117.671760559082,22,2.07067225124734,-0.174143474963944 +-153.38366,57.118206,10.28995904,37250.0552359603,790427.773293373,93.8800201416016,30,1.9725731741028,-0.530467323417211 +-153.01599,57.1158072,10.33344696,59473.7595936249,790427.779295572,13.7963819503784,30,1.13976520922721,-3.55546355890422 +-152.95472,57.1153002,9.970977079,63177.5244034049,790427.772069448,12.9475631713867,30,1.11218803862546,-3.65563171383793 +-152.89344,57.1147626,13.22148088,66882.0011139513,790427.7776951,62.0689010620117,30,1.79287405621302,-1.18318581082758 +-152.83217,57.1141944,13.719616,70585.9873076679,790427.776849484,112.707641601562,130,2.05195336230063,-0.242135822521245 +-152.77091,57.1135956,13.719616,74289.4892820049,790427.768135208,144.16389465332,130,2.15885650645684,0.146166910249308 +-152.70964,57.1129662,13.719616,77993.7220494324,790427.773657862,152.764831542969,130,2.1840233854912,0.237580198244533 +-152.64837,57.1123062,13.719616,81698.0875486475,790427.78309435,149.305404663086,130,2.17407552890969,0.201446743739555 +-152.58711,57.1116156,13.719616,85401.9877178069,790427.783905389,92.8571243286133,130,1.96781522997033,-0.547749534558775 +-152.52585,57.1108943,13.719616,89106.0334577541,790427.777010923,130.833755493164,130,2.11671980769707,-0.00688560665740511 +-152.4646,57.1101425,13.719616,92809.6262202894,790427.77110479,150.217330932617,130,2.17672004115148,0.211052367020676 +-152.40334,57.1093601,13.719616,96513.9812525123,790427.78278461,136.531219482422,130,2.13523196931579,0.0603558482387727 +-152.34209,57.1085471,13.719616,100217.896132411,790427.783922184,75,31,1.8750612633917,-0.8846584157902 +-152.28084,57.1077034,13.719616,103921.981799487,790427.77772871,77.3149871826172,31,1.88826368822379,-0.836703440452826 +-152.2196,57.1068292,13.719616,107625.639620583,790427.770724364,82.2391891479492,31,1.91507881966789,-0.739303229247341 +-152.15835,57.1059244,13.719616,111330.084881249,790427.784028949,82.6675567626953,31,1.9173351022563,-0.731107766879068 +-152.09712,57.104989,13.719616,115033.510798904,790427.767790112,82.2933197021484,31,1.91536458206225,-0.73826525866633 +-152.03588,57.104023,13.719616,118737.736736709,790427.772752806,77.0388641357422,31,1.88670987090755,-0.842347348449039 +-151.97465,57.1030264,13.719616,122441.560268272,790427.764184865,72.6175231933594,31,1.86104143210372,-0.935582444686406 +-151.91342,57.1019993,13.719616,126145.591688996,790427.771047544,73.3798675537109,31,1.86557692354497,-0.919108245213626 +-151.85219,57.1009416,13.719616,129849.837616397,790427.782681814,76.7390594482422,31,1.88501647196757,-0.848498256743228 +-151.79097,57.0998532,13.719616,133553.700350515,790427.768334563,82.3000030517578,31,1.9153998513163,-0.738137150668773 +-151.72975,57.0987344,13.719616,137257.789421143,790427.780995537,78.8805160522461,31,1.89696974318455,-0.805080563879882 +-151.66854,57.0975849,13.719616,140961.507868926,790427.766514161,99.5211563110352,31,1.99791541333332,-0.438417077136708 +-151.60732,57.0964049,13.719616,144666.069919912,790427.789651658,132.48908996582,134,2.12218011704473,0.0129477954207682 +-151.54612,57.0951943,13.719616,148369.669165175,790427.774474415,142.000152587891,134,2.15228881105942,0.122311165958966 +-151.48492,57.0939531,13.719616,152073.520602067,790427.764020472,160.091766357422,134,2.20436899639469,0.311481264261525 +-151.42372,57.0926814,13.719616,155777.630078507,790427.770044797,223.720291137695,134,2.34970537582433,0.839384477482662 +-151.36252,57.0913791,13.719616,159482.004286608,790427.782009328,354.2294921875,231,2.54928471654091,1.56431360858051 +-151.30133,57.0900463,13.719616,163186.044693867,790427.787125592,360.360290527344,231,2.55673692838084,1.59138216905615 +-151.24015,57.0886829,13.719616,166889.758010782,790427.773212585,360.773895263672,231,2.55723510549659,1.59319169053446 +-151.17897,57.087289,13.719616,170593.754397588,790427.776096836,381.209136962891,330,2.58116330142329,1.68010572792733 +-151.11779,57.0858645,13.719616,174298.040583054,790427.785300864,492.223724365234,330,2.6921625421433,2.08328665255995 +-135.09586,55.6108394,13.719616,1174378.03039848,790427.849154162,625,450,2.79588001734408,2.4600181264039 +-135.03942,55.6014902,13.719616,1178081.98200892,790427.834799933,282,351,2.45024910831936,1.20458801194299 +-134.98301,55.5921138,13.719616,1181785.82081152,790427.789709246,239,251,2.37839790094814,0.94360391839434 +-134.92663,55.5827101,13.719616,1185489.55420295,790427.701922342,238.579971313477,251,2.37763398202863,0.940829146834527 +-134.87027,55.5732793,13.719616,1189193.78447287,790427.770611787,247.015441894531,251,2.39272410354291,0.995640775323879 +-134.81394,55.5638214,13.719616,1192897.91146597,790427.816560557,271.520599365234,251,2.43380278365335,1.14485026650764 +-134.75764,55.5543362,13.719616,1196601.94574546,790427.817156154,289,350,2.46089784275655,1.24326725487026 +-134.70137,55.544824,13.719616,1200305.88198037,790427.803186469,292,350,2.46538285144842,1.25955808658806 +-134.64513,55.5352846,13.719616,1204009.73073184,790427.752057728,283,251,2.45178643552429,1.21017202314816 +-134.58892,55.5257182,13.719616,1207713.48978691,790427.683879803,233,251,2.36735592102602,0.903496295622358 +-134.53273,55.5161247,13.719616,1211417.77087029,790427.769163451,193,151,2.28555730900777,0.60638038912377 +-134.47657,55.5065041,13.719616,1215121.97379343,790427.825392603,187,151,2.2718416065365,0.556561042896859 +-134.42045,55.4968566,13.719616,1218825.49188813,790427.689147296,184,151,2.26481782300954,0.531048656339518 +-134.36435,55.487182,13.719616,1222529.54446624,790427.704390135,178,151,2.25042000230889,0.478751662007618 +-134.30828,55.4774804,13.719616,1226233.52806755,790427.697608973,174.543975830078,151,2.24190486427078,0.447822250190802 +-134.25223,55.4677518,13.719616,1229938.05116987,790427.85280742,135.264572143555,151,2.13118406313632,0.045652697607492 +-134.19622,55.4579963,13.719616,1233641.90589936,790427.809600231,108.941230773926,151,2.03719227744808,-0.295752295938767 +-134.14024,55.4482139,13.719616,1237345.70069587,790427.751439864,89.4304733276367,151,1.95148552934378,-0.607063668195008 +-134.08428,55.4384045,13.719616,1241050.04728441,790427.853375014,116.233535766602,151,2.06533144902776,-0.193542793042173 +-134.02836,55.4285683,13.719616,1244753.734448,790427.762327404,108.811408996582,151,2.03667443400636,-0.29763325112633 +-133.97246,55.4187051,13.719616,1248457.98155782,790427.830153216,104.84317779541,151,2.02054017593438,-0.356237481619492 +-133.9166,55.4088152,13.719616,1252161.57403265,790427.712180036,105.354400634766,151,2.02265268072704,-0.348564261243678 +-133.86076,55.3988983,13.719616,1255865.73456778,790427.751882297,93.6136779785156,50,1.97133930853087,-0.534949075354746 +-133.80495,55.3889547,13.719616,1259569.85287512,790427.792016582,82.633659362793,50,1.91715698555178,-0.731754737589459 +-133.74917,55.3789843,13.719616,1263273.93628848,790427.820802426,66.0565719604492,50,1.81991603200616,-1.08496163619857 +-133.69342,55.3689871,13.18452835,1266977.98881864,790427.837100183,49.9425735473633,50,1.69847091784355,-1.52608495472383 +-133.6377,55.3589632,6.517055347,1270682.01110897,790427.850396237,16.7701206207275,50,1.22453618632272,-3.24755117404755 +-133.58201,55.3489125,5.760124562,1274386.01050315,790427.848940932,30.0071182250977,50,1.47722428935911,-2.32971585945419 +-133.52635,55.3388351,10.56594362,1278089.98761562,790427.84222926,112.212341308594,50,2.05004062400992,-0.249083433942959 +-133.47072,55.328731,12.94515648,1281793.94640821,790427.829141793,154.096923828125,50,2.18779396916744,0.251276034388384 +-133.30401,55.2982587,7.126866412,1292905.74557109,790427.761739353,40.8391494750977,50,1.61107668879886,-1.84352573941059 +-133.2485,55.288048,6.682957779,1296609.66372523,790427.733287134,43.3215751647949,50,1.63670423911076,-1.75043916184665 +-133.19302,55.2778107,7.073016045,1300313.57981672,790427.703551888,33.431396484375,50,1.52415451816574,-2.15925187320762 +-156.44469,57.0621706,13.66726651,-147949.920009232,786723.764413494,63.6773223876953,20,1.80398479316087,-1.14282844291294 +-156.38354,57.0633767,13.57682373,-144245.969026577,786723.770684843,30.0896320343018,20,1.47841687679128,-2.32538404150221 +-156.32239,57.0645522,13.719616,-140542.262904289,786723.778691431,92.6476669311523,20,1.96683448731726,-0.551311871806569 +-156.26123,57.0656972,13.719616,-136838.190067144,786723.778414515,117.986526489258,20,2.07183241573443,-0.169929426402919 +-156.20007,57.0668116,13.719616,-133134.349550411,786723.779865513,76.6530532836914,20,1.88452945857525,-0.850267228391593 +-156.1389,57.0678955,13.719616,-129430.129797496,786723.774171332,75.8019714355469,20,1.87968050078305,-0.867880027123196 +-156.07773,57.0689488,13.719616,-125726.12982127,786723.770256679,125.857635498047,121,2.09987956834745,-0.0680541626580607 +-156.01656,57.0699716,13.719616,-122022.342999375,786723.778767875,220.031814575195,220,2.34248548034723,0.813159756346493 +-155.95538,57.0709638,13.719616,-118318.158491393,786723.770237649,256.495208740234,220,2.40907925702245,1.05504736098712 +-155.8942,57.0719255,13.719616,-114614.174609312,786723.774273984,265.239105224609,220,2.4236375541643,1.10792725155805 +-155.83302,57.0728566,13.719616,-110910.385405992,786723.779254505,290.182037353516,220,2.46267052553903,1.24970614471027 +-155.77183,57.0737572,13.719616,-107206.179381392,786723.779742964,286.064697265625,220,2.45646426560418,1.22716323718395 +-155.71064,57.0746271,13.719616,-103502.155769236,786723.77024623,282.142639160156,220,2.45046872441352,1.20538572028163 +-155.64945,57.0754666,13.719616,-99798.3074187982,786723.783816653,276.454620361328,220,2.44162385266022,1.17325862149591 +-155.58825,57.0762754,13.719616,-96094.0239880019,786723.772103933,273.469085693359,220,2.43690823863426,1.1561301653834 +-155.52706,57.0770537,13.719616,-92390.5084740246,786723.786529773,269.918579101562,220,2.43123277904923,1.13551527623312 +-155.46585,57.0778014,13.719616,-88685.9401172249,786723.773823096,262.770660400391,220,2.41957687254094,1.09317769686807 +-155.40465,57.0785185,13.719616,-84982.1273730764,786723.77535712,262.229797363281,220,2.41868203935705,1.08992740733336 +-155.34345,57.079205,13.719616,-81278.4590344732,786723.776872389,255.338607788086,220,2.40711648609937,1.04791801676391 +-155.28224,57.079861,13.719616,-77574.3236782391,786723.77751482,248.018676757812,220,2.39448438609818,1.00203462399929 +-155.22103,57.0804864,13.719616,-73870.3201631652,786723.778603601,238.795547485352,220,2.3780262248,0.942253884537382 +-155.15982,57.0810812,13.719616,-70166.4421959586,786723.77983552,229.482894897461,220,2.36075031981448,0.879502866595746 +-155.0986,57.0816454,13.719616,-66462.078567328,786723.770914508,214.919998168945,220,2.3322768281966,0.776079017895966 +-155.03739,57.0821791,13.719616,-62758.4326396167,786723.783300554,203.975296020508,220,2.3095775720747,0.693628840648497 +-154.97617,57.0826821,13.719616,-59054.2886460827,786723.774956595,161.72314453125,121,2.20877217712919,0.327474873482139 +-154.91495,57.0831546,13.719616,-55350.2448686281,786723.777967392,109.684989929199,121,2.04014719970835,-0.285019174870705 +-154.85373,57.0835965,13.719616,-51646.2951860139,786723.780943417,80.5,22,1.90579588036787,-0.773021514399693 +-154.79251,57.0840078,13.719616,-47942.4333022681,786723.783670392,75.3720245361328,22,1.8772101808292,-0.876852934295086 +-154.73128,57.0843885,13.719616,-44238.04800558,786723.779287567,73.7874603271484,22,1.86798256272486,-0.910370277074481 +-154.67006,57.0847386,13.719616,-40534.3428302728,786723.781490604,51.6693267822266,22,1.71323280300746,-1.47246557434699 +-154.60883,57.0850581,13.719616,-36830.1016484008,786723.777344932,29.0611095428467,22,1.4633121914877,-2.38024856983122 +-154.5476,57.085347,13.65868881,-33125.9230782119,786723.773356837,15.6524782180786,22,1.19458310809524,-3.35634930362945 +-153.56792,57.0858088,7.805303583,26137.5573676157,786723.773663081,11.4160184860229,30,1.05751466336266,-3.85422101812736 +-153.44546,57.0853158,13.719616,33545.7633266501,786723.774613037,120.140663146973,30,2.0796900248169,-0.141388347430485 +-153.32301,57.0847004,4.812345091,40953.5925079702,786723.769541729,24.0603580474854,30,1.38130208588372,-2.6781326813995 +-153.13934,57.0835479,12.51864155,52065.5716380164,786723.767941735,19.6414337158203,30,1.29317318569857,-2.9982420013644 +-153.07812,57.0831026,13.24849977,55769.5315687327,786723.772079023,34.3169479370117,30,1.53550865583589,-2.11801040439609 +-153.0169,57.0826267,13.719616,59473.5862938186,786723.776206548,43.1538391113281,30,1.63501943807437,-1.75655884010091 +-152.95568,57.0821202,13.719616,63177.7421088149,786723.780555087,65.0684661865234,30,1.81337056953422,-1.10873662415764 +-152.89446,57.081583,13.719616,66882.0054946517,786723.774210046,75.1590881347656,30,1.87598150239653,-0.881315845062291 +-152.83325,57.0810154,13.719616,70585.7772731373,786723.780283833,109.221740722656,30,2.03830909382761,-0.291695700077181 +-152.77204,57.0804171,13.719616,74289.6692113911,786723.77508424,151.753433227539,130,2.18113852521622,0.227101562304697 +-152.71083,57.0797882,13.719616,77993.6874173655,786723.770061517,154.245697021484,130,2.18821305739966,0.252798282467497 +-152.64962,57.0791288,13.719616,81697.8379573465,786723.776679974,157.465591430664,130,2.19718566870113,0.285389367752663 +-152.58842,57.0784388,13.719616,85401.5224149119,786723.771239878,115.29598236084,130,2.06181417399966,-0.206318539874481 +-152.52721,57.0777182,13.719616,89105.9569131805,786723.779237099,132.408279418945,130,2.12191514215459,0.011985330988401 +-152.46601,57.076967,13.719616,92809.9379127077,786723.774744056,146.503479003906,130,2.16584793796152,0.171561785027532 +-152.40481,57.0761853,13.719616,96514.0763518393,786723.782142891,133.318298339844,130,2.12488976173668,0.0227899983514956 +-152.34362,57.075373,13.719616,100217.773852885,786723.775562947,74.9752807617188,31,1.8749181007475,-0.885178423376639 +-152.28243,57.0745301,13.719616,103921.641620954,786723.769372962,76.4175338745117,31,1.8831930181473,-0.855121561483975 +-152.22124,57.0736567,13.719616,107625.685646066,786723.775139071,77.9842071533203,31,1.89200666114415,-0.823107894455244 +-152.16005,57.0727527,13.719616,111329.912494789,786723.782126252,79.2538986206055,31,1.8990206350257,-0.797631139329997 +-152.09887,57.0718181,13.719616,115033.723539111,786723.773451059,76.1790390014648,31,1.88183548973483,-0.860052492155242 +-152.03769,57.070853,13.719616,118737.729651473,786723.776929058,72.7919769287109,31,1.86208351437342,-0.931797304442952 +-151.97651,57.0698573,13.719616,122441.937426989,786723.781870419,74.8466339111328,31,1.87417227352753,-0.887887480719826 +-151.91534,57.068831,13.719616,126145.748235264,786723.769762764,81.2830581665039,31,1.91000003499708,-0.757750824801193 +-151.85417,57.0677742,13.719616,129849.772915454,786723.770138206,80.4157028198242,31,1.90534086195888,-0.774674271136328 +-151.793,57.0666869,13.719616,133554.017720124,786723.783507562,77.2322616577148,31,1.88779875283764,-0.838392218481091 +-151.73184,57.065569,13.719616,137257.88436658,786723.778573363,93.5916442871094,31,1.97123707734938,-0.535320408185589 +-151.67068,57.0644206,13.719616,140961.983660481,786723.786584103,111.836067199707,134,2.04858188637463,-0.254381985399495 +-151.60953,57.0632416,13.719616,144665.717337822,786723.775157004,125.942375183105,134,2.10017187952654,-0.0669924050216903 +-151.54838,57.0620321,13.719616,148369.696181807,786723.77668474,146.807098388672,134,2.16674705501125,0.174827634785707 +-151.48723,57.060792,13.719616,152073.926862501,786723.780598153,178.751129150391,134,2.25224879387024,0.485394354947497 +-151.42609,57.0595214,13.719616,155777.810309572,786723.775194008,339.658355712891,231,2.53104230285245,1.49805195516076 +-151.36495,57.0582203,13.719616,159481.957684299,786723.783427199,451.18701171875,330,2.65435658915777,1.94596464042318 +-151.30382,57.0568886,13.719616,163185.770768936,786723.770201782,507.576232910156,330,2.70550127820276,2.13173674918221 +-151.24269,57.0555265,13.719616,166889.85982684,786723.781922461,520.635314941406,330,2.71653362317393,2.17180937506225 +-151.18157,57.0541338,13.719616,170593.62710133,786723.771255335,493.841766357422,330,2.69358781733243,2.08846365886091 +-151.12045,57.0527106,13.719616,174297.68329625,786723.77459718,677.468444824219,430,2.83088907141674,2.58718100337471 +-135.05597,55.5695902,13.719616,1178081.88796208,786723.806765304,575.483642578125,450,2.76003298384936,2.32981146898907 +-134.9996,55.5602213,13.719616,1181785.95488537,786723.823007394,355.058074951172,251,2.55029939409181,1.56799920706319 +-134.94326,55.5508252,13.719616,1185489.90948511,786723.80455428,256.703369140625,251,2.40943156866981,1.05632705745009 +-134.88695,55.541402,13.719616,1189193.75283391,786723.760815699,277,251,2.44247976906445,1.17636755417894 +-134.83067,55.5319517,13.719616,1192897.48913407,786723.690518148,293,251,2.46686762035411,1.26495119104877 +-134.77441,55.5224742,13.719616,1196601.73067824,786723.761900037,300,350,2.47712125471966,1.30219531774308 +-134.71818,55.5129696,13.719616,1200305.87357991,786723.805320914,287,251,2.45788189673399,1.23231247807964 +-134.66198,55.5034379,13.719616,1204009.92202487,786723.819531059,237,251,2.3747483460101,0.930347693172715 +-134.60581,55.4938791,13.719616,1207713.88019335,786723.803288636,203,251,2.30749603791321,0.686068114444982 +-134.54967,55.4842933,13.719616,1211417.74904382,786723.766025386,194,151,2.28780172993023,0.614532766535627 +-134.49356,55.4746804,13.719616,1215121.53594372,786723.695843687,184,151,2.26481782300954,0.531048656339518 +-134.43747,55.4650406,13.719616,1218825.8435038,786723.796372678,188,151,2.27415784926368,0.564974297603475 +-134.38141,55.4553737,13.719616,1222530.0773991,786723.862658208,186,151,2.26951294421792,0.548102676689368 +-134.32539,55.4456799,13.719616,1226233.63036248,786723.730162791,177,151,2.24797326636181,0.46986441867983 +-134.26939,55.4359591,13.719616,1229937.71957914,786723.755750873,117.505958557129,151,2.0700598896109,-0.176367747212926 +-134.21342,55.4262114,13.719616,1233641.74097817,786723.76478943,93.4042892456055,151,1.97036682005157,-0.538481431087389 +-134.15748,55.4164367,13.719616,1237345.70192057,786723.745435604,103.483085632324,151,2.01486936991996,-0.376835467673048 +-134.10157,55.4066352,13.719616,1241049.59993412,786723.717793691,111.860939025879,151,2.04867846072838,-0.254031199781617 +-134.04568,55.3968068,13.719616,1244754.0472753,786723.857464772,116.749397277832,151,2.06725464718601,-0.186557188396017 +-133.98983,55.3869515,13.719616,1248457.83817859,786723.788968476,112.782974243164,151,2.05224354335006,-0.241081802123775 +-133.93401,55.3770694,13.719616,1252161.57830487,786723.708645509,115.331588745117,151,2.06194827467341,-0.205831447951287 +-133.87821,55.3671605,13.719616,1255865.87659725,786723.804432283,108.46004486084,151,2.03526977973074,-0.302735356383637 +-133.82245,55.3572248,13.719616,1259569.52724682,786723.697515574,95.4176025390625,151,1.97962850028478,-0.504840364933667 +-133.76671,55.3472623,13.719616,1263273.74410106,786723.765509242,80.4985504150391,50,1.90578805984094,-0.773049920785703 +-133.711,55.337273,13.719616,1266977.92625537,786723.81816201,68.5381011962891,50,1.83593206841312,-1.02678682053656 +-133.54406,55.3071449,13.719616,1278089.67936915,786723.743948549,145.886337280273,50,2.16401462073767,0.164902653589667 +-133.48847,55.2970488,13.44806709,1281793.7491263,786723.765785267,111.208778381348,50,2.04613907008873,-0.263254991399074 +-133.21097,55.2461688,8.818380238,1300313.86963521,786723.80308958,23.3425121307373,50,1.36814759317498,-2.72591355358366 +-156.56462,57.0265056,9.014374258,-155358.111756971,783019.77496632,66.0685806274414,20,1.81999497682056,-1.08467488609958 +-156.44244,57.0290071,13.71656487,-147949.915249214,783019.766289214,63.0201377868652,20,1.79947934837797,-1.15919350434642 +-156.38135,57.0302121,13.719616,-144246.195663659,783019.777270503,180.814529418945,20,2.2572333254366,0.50349959632347 +-156.32025,57.0313866,13.719616,-140542.114724344,783019.776522321,81.8251876831055,20,1.91288701012601,-0.747264507108195 +-156.25915,57.0325305,13.719616,-136838.272038309,783019.774601013,111.844055175781,20,2.04861290508023,-0.254269316607142 +-156.19804,57.033644,13.719616,-133134.055116089,783019.773216518,113.499649047852,121,2.0549945186497,-0.231089474628989 +-156.13693,57.0347269,13.719616,-129430.063932167,783019.770683965,94.5131530761719,121,1.97549225201087,-0.519864399267304 +-156.07582,57.0357793,13.719616,-125726.291858325,783019.777635323,186.550964355469,121,2.27079749842202,0.55276854420693 +-156.0147,57.0368012,13.719616,-122022.127171843,783019.775188669,235.73258972168,220,2.3724196273181,0.92188912220087 +-155.95358,57.0377925,13.719616,-118318.169423871,783019.771183424,239.99836730957,220,2.38020828724971,0.950179758177331 +-155.89246,57.0387533,13.719616,-114614.412014409,783019.776296662,289.042938232422,220,2.46096236335253,1.24350161209086 +-155.83133,57.0396836,13.719616,-110910.243218223,783019.773363789,295.700256347656,220,2.47085170102366,1.27942250921043 +-155.7702,57.0405834,13.719616,-107206.262255754,783019.779751568,287.213500976562,220,2.45820485082726,1.23348553952666 +-155.70907,57.0414526,13.719616,-103502.463160664,783019.783867786,284.411560058594,220,2.45394724454587,1.21802069827082 +-155.64793,57.0422913,13.719616,-99798.2338976957,783019.781422243,280.862457275391,220,2.44849369118521,1.19821183586581 +-155.58679,57.0430994,13.719616,-96094.1739517481,783019.776994516,274.568664550781,220,2.43865097139595,1.1624602681993 +-155.52565,57.043877,13.719616,-92390.276779942,783019.781351771,271.019683837891,220,2.43300083431254,1.14193735760267 +-155.4645,57.044624,13.719616,-88685.9308988233,783019.7696056,267.884826660156,220,2.42794811530889,1.12358443999183 +-155.40336,57.0453405,13.719616,-84982.340731233,783019.77981916,262.147766113281,220,2.41854616123415,1.08943385920749 +-155.34221,57.0460264,13.719616,-81278.289298691,783019.774336661,257.684875488281,220,2.41108892889339,1.06234706283984 +-155.28106,57.0466818,13.719616,-77574.3755701597,783019.777339409,250.072967529297,220,2.39806674775859,1.0150467840577 +-155.2199,57.0473067,13.719616,-73869.9878136906,783019.777387492,240.590148925781,220,2.38127784098071,0.954064682609383 +-155.15875,57.0479009,13.719616,-70166.3311059667,783019.774663662,228.95881652832,220,2.35975737158452,0.87589619520888 +-155.09759,57.0484647,13.719616,-66462.1876257368,783019.780670535,216.21711730957,220,2.33489007286808,0.785571068437092 +-155.03643,57.0489978,13.719616,-62758.1571393679,783019.772779266,190.092926025391,121,2.27896595565923,0.582438712402324 +-154.97527,57.0495004,13.719616,-59054.2329966954,783019.773051511,142.420394897461,121,2.15357218562947,0.126972748708974 +-154.91411,57.0499725,13.719616,-55350.408936594,783019.781244323,91.7230987548828,121,1.96247871842394,-0.567133267687301 +-154.85294,57.050414,13.719616,-51646.0733676502,783019.778192286,78.8219833374023,22,1.89664735848762,-0.806251557116855 +-154.79178,57.0508249,13.719616,-47942.4309435786,783019.779792784,79.2456207275391,22,1.89897527156594,-0.797795912363858 +-154.73061,57.0512053,13.719616,-44238.2643020317,783019.78201174,62.4095306396484,22,1.79525091641557,-1.17455237614849 +-154.66944,57.051555,13.719616,-40534.1728786578,783019.770120329,40.4256782531738,22,1.60665731513724,-1.85957816596439 +-154.60827,57.0518743,13.719616,-36830.150042196,783019.777431629,29.4433403015137,22,1.46898707849915,-2.35963576043163 +-154.5471,57.0521629,13.719616,-33126.1898361566,783019.770308481,20.857702255249,22,1.31926646359052,-2.90346376829784 +-153.93536,57.0533684,10.68783969,3913.78019264948,783019.776994158,159.525604248047,22,2.20283039830992,0.305892636858003 +-153.56831,57.0526243,11.43039201,26138.0420235918,783019.772625342,64.1973342895508,30,1.80751699493218,-1.12999847788877 +-153.50714,57.0523933,13.55165579,29841.9015044391,783019.771415679,87.7914276123047,30,1.94345211132262,-0.636243335413663 +-153.44597,57.0521318,13.719616,33545.8115618473,783019.777842232,120.17756652832,30,2.07982340575126,-0.140903869806184 +-153.3848,57.0518397,12.86862862,37249.7785628373,783019.780870497,60.4080352783203,30,1.78109471088822,-1.22597175520715 +-153.14013,57.0503655,13.719616,52065.73612125,783019.776534121,29.537353515625,30,1.47037158085241,-2.35460685270827 +-153.07896,57.0499205,13.719616,55770.0820729372,783019.775592193,45.128719329834,30,1.65445300921529,-1.68597056282362 +-153.0178,57.049445,13.719616,59473.9170704478,783019.774527638,69.0072860717773,30,1.83889494774757,-1.01602479710389 +-152.95664,57.048939,13.719616,63177.8528484969,783019.781410261,77.1482925415039,30,1.88732631862977,-0.840108234370224 +-152.89548,57.0484023,13.719616,66881.8960394073,783019.774165001,87.2957305908203,30,1.94099300400123,-0.645175515104039 +-152.83432,57.0478351,13.719616,70586.0525736869,783019.775371593,111.007911682129,130,2.0453539326375,-0.266106834722466 +-152.77317,57.0472374,13.719616,74289.7232382887,783019.774117794,165.78141784668,130,2.21953584962249,0.366571604235778 +-152.71202,57.0466091,13.719616,77993.5199825973,783019.769604145,119.568496704102,130,2.07761676903529,-0.148919004195396 +-152.65086,57.0459503,13.719616,81698.0543431313,783019.785595739,150,130,2.17609125905568,0.208768450976442 +-152.58972,57.0452609,13.719616,85401.5163958577,783019.77434664,124.078628540039,130,2.09369698450909,-0.0905110718441209 +-152.52857,57.0445409,13.719616,89105.7288493867,783019.77309615,133.932205200195,130,2.12688501957365,0.0300373443186818 +-152.46742,57.0437904,13.719616,92810.0922612667,783019.781049398,142.521240234375,130,2.15387959297032,0.128089339913717 +-152.40628,57.0430094,13.719616,96514.0074151675,783019.784036169,129.096893310547,130,2.11091579118725,-0.0279674512523005 +-152.34514,57.0421978,13.719616,100218.086318674,783019.78469331,76.2695083618164,31,1.88235094690742,-0.858180204578285 +-152.28401,57.0413557,13.719616,103921.729496605,783019.778922966,74.9575805664062,31,1.87481556022208,-0.885550879832915 +-152.22288,57.040483,13.719616,107625.548975737,783019.770507468,74.127067565918,31,1.8699768199635,-0.903126565566056 +-152.16175,57.0395798,13.719616,111329.550732177,783019.771026175,73.7261734008789,31,1.86762169336316,-0.911681057598565 +-152.10062,57.038646,13.719616,115033.741338564,783019.769758662,69.634651184082,31,1.84282540445489,-1.00174825647888 +-152.0395,57.0376818,13.719616,118737.520946282,783019.77159036,72.6372146606445,31,1.86115918241963,-0.935154741929732 +-151.97838,57.036687,13.719616,122441.501929095,783019.771437598,84.4396896362305,31,1.92654662835992,-0.697648874839424 +-151.91726,57.0356616,13.719616,126145.690568894,783019.769781714,85.4585189819336,31,1.93175536211156,-0.678729267132817 +-151.85614,57.0346058,13.719616,129850.092426258,783019.789429626,82.58642578125,31,1.91690867089481,-0.732656687299631 +-151.79504,57.0335194,13.719616,133553.50351434,783019.7683596,79.5076904296875,31,1.90040913808596,-0.792587699896922 +-151.73393,57.0324025,13.719616,137257.746151357,783019.776909164,89.2597198486328,31,1.95065551942605,-0.610078501124641 +-151.67283,57.0312551,13.719616,140961.61563844,783019.774839413,90.9689483642578,31,1.95889317412992,-0.580156987979414 +-151.61173,57.0300771,13.719616,144665.724096764,783019.771660374,100.980781555176,134,2.00423872765662,-0.415448994660898 +-151.55063,57.0288687,13.719616,148370.076979696,783019.790248853,134.936050415039,134,2.13012799418405,0.0418167537407573 +-151.48954,57.0276297,13.719616,152074.075871547,783019.785981662,226.725036621094,134,2.35549948071766,0.860430320257413 +-151.42846,57.0263602,13.719616,155777.726614707,783019.768937366,444.297058105469,330,2.6476734375875,1.92168952635861 +-151.36738,57.0250603,13.719616,159481.640482724,783019.773221969,600.95068359375,330,2.77883883353037,2.3981196827544 +-151.3063,57.0237298,13.719616,163185.824591567,783019.777157527,670.765014648438,330,2.82657040285867,2.57149436650106 +-151.24523,57.0223688,13.719616,166889.679276427,783019.767408785,632.652526855469,430,2.80116524697972,2.4792155889953 +-151.18416,57.0209774,13.719616,170593.815776818,783019.779797542,638.698486328125,430,2.80529588691089,2.4942192522273 +-135.07249,55.5376865,13.719616,1178081.90950592,783019.815480971,691,450,2.8394780473742,2.61837861558999 +-135.01617,55.5283251,13.719616,1181785.59539557,783019.715669076,448,351,2.65127801399814,1.9347823767306 +-134.95987,55.5189366,13.719616,1185489.76752957,783019.766554798,264,251,2.42160392686983,1.10054053676951 +-134.9036,55.509521,13.719616,1189193.82464233,783019.789457633,284,251,2.45331834004704,1.21573633762386 +-134.84736,55.5000782,13.719616,1192897.77410456,783019.772417152,291,251,2.46389298898591,1.25414648087514 +-134.79115,55.4906083,13.719616,1196601.61696246,783019.724847119,292,251,2.46538285144842,1.25955808658806 +-134.73496,55.4811113,13.719616,1200305.96288044,783019.826222123,262,251,2.41830129131975,1.08854442178556 +-134.67881,55.4715872,13.719616,1204009.60509773,783019.714365867,203,251,2.30749603791321,0.686068114444982 +-134.62268,55.4620361,13.719616,1207713.7555365,783019.76073423,194,151,2.28780172993023,0.614532766535627 +-134.56658,55.452458,13.719616,1211417.81287122,783019.783339194,189,151,2.27646180417324,0.573342919449214 +-134.51051,55.4428528,13.719616,1215121.78446642,783019.770276104,188,151,2.27415784926368,0.564974297603475 +-134.45447,55.4332207,13.719616,1218825.66802304,783019.741640633,183,151,2.26245108973043,0.522452005536869 +-134.39845,55.4235615,13.719616,1222530.07959909,783019.858968574,181,151,2.25767857486918,0.505116869349467 +-134.34247,55.4138754,13.719616,1226233.80590215,783019.774746692,179,151,2.25285303097989,0.487589116596209 +-134.28651,55.4041624,13.719616,1229938.0619719,783019.856484165,171,151,2.23299611039215,0.415463113292133 +-134.23059,55.3944225,13.719616,1233641.64094961,783019.733125591,143.283157348633,151,2.15619514294134,0.136500078332242 +-134.17469,55.3846556,13.719616,1237345.76113987,783019.763780375,138.596298217773,151,2.14175163081645,0.0840371197058491 +-134.11882,55.3748619,13.719616,1241049.81460306,783019.783346089,125.788665771484,151,2.09964151062705,-0.0689188562470158 +-134.06298,55.3650413,13.719616,1244753.80867731,783019.779985036,123.877960205078,151,2.09299404557906,-0.0930643466767105 +-134.00717,55.3551939,13.719616,1248457.74412547,783019.763153066,120.648963928223,151,2.08152359676128,-0.134728290774965 +-133.95139,55.3453196,13.719616,1252161.62829235,783019.721033267,115.509033203125,151,2.06261594887637,-0.20340626467293 +-133.89563,55.3354186,13.719616,1255866.06406469,783019.862826809,113.081382751465,151,2.05339111037337,-0.2369135111469 +-133.83991,55.3254907,13.719616,1259569.85115018,783019.788448178,109.295631408691,151,2.03860280336768,-0.290628863194624 +-133.78422,55.3155362,13.719616,1263273.5890507,783019.717169305,99.1284103393555,151,1.99619814172375,-0.444654697780786 +-133.72855,55.3055548,13.719616,1266977.89723846,783019.806730086,80.8179244995117,50,1.90750769305066,-0.766803722135808 +-133.67292,55.2955468,7.603602986,1270681.55873136,783019.706853648,20.4464912414551,50,1.31061879081685,-2.93487458410336 +-133.56173,55.2754505,13.719616,1278090.0016481,783019.836667328,244.661804199219,50,2.38856617400936,0.980537988466765 +-133.50619,55.2653624,13.719616,1281793.57332598,783019.701530267,55.6076240539551,50,1.74513433938008,-1.35659008863664 +-133.2289,55.2145226,10.86983961,1300313.5610733,783019.698093162,37.1959800720215,50,1.57049600636375,-1.99092636089483 +-156.74533,56.9893656,9.236621385,-166470.335442131,779315.786338906,74.4459457397461,20,1.87184105143944,-0.89635514474081 +-156.68431,56.9907219,11.9765674,-162766.147982202,779315.77729362,37.2498054504395,20,1.57112400884213,-1.9886452766436 +-156.50123,56.994608,13.07439775,-151653.997428681,779315.771668215,179.516372680664,20,2.25410406428258,0.492133226632015 +-156.4402,56.9958424,13.38266451,-147950.265905599,779315.780451243,37.6227035522461,20,1.57545000056137,-1.97293203995836 +-156.37916,56.9970463,13.719616,-144246.178362374,779315.774065555,160.183486938477,20,2.20461774332664,0.312384784117801 +-156.31812,56.9982198,13.719616,-140542.334198825,779315.785920487,98.4852676391602,20,1.9933712694667,-0.454922704688077 +-156.25707,56.9993627,13.719616,-136838.121930586,779315.772538013,143.498184204102,121,2.15684640563358,0.138865650319317 +-156.19602,57.0004752,13.719616,-133134.14057629,779315.777395634,144.944885253906,121,2.16120289478452,0.154689662381342 +-156.13497,57.0015571,13.719616,-129430.384639628,779315.777647879,123.716972351074,121,2.09242928324101,-0.0951157246877355 +-156.07391,57.0026086,13.719616,-125726.24111647,779315.776151263,200.20881652832,220,2.30148319844445,0.664227765259187 +-156.01285,57.0036296,13.719616,-122022.310160442,779315.781290973,228.160140991211,220,2.35823977654347,0.870383856855042 +-155.95178,57.0046201,13.719616,-118317.979493397,779315.774758545,231.303436279297,220,2.36418208476392,0.891968016415373 +-155.89072,57.00558,13.719616,-114614.455246951,779315.781109695,298.862213134766,220,2.47547100816588,1.29620115123247 +-155.82964,57.0065095,13.719616,-110909.912433704,779315.770418844,295.461334228516,220,2.47050065465918,1.27814740861602 +-155.76857,57.0074084,13.719616,-107206.163522102,779315.771699494,288.857849121094,220,2.46068417310182,1.24249114569689 +-155.70749,57.0082769,13.719616,-103501.989595198,779315.773988168,285.618927001953,220,2.45578698328673,1.22470315449136 +-155.64641,57.0091148,13.719616,-99797.9910169754,779315.771252249,281.897003173828,220,2.45009045894366,1.20401175212739 +-155.58533,57.0099222,13.719616,-96094.1612384313,779315.774244352,279.766845703125,220,2.44679624631977,1.19204623161553 +-155.52425,57.0106991,13.719616,-92390.4940070735,779315.782574892,272.315460205078,220,2.43507229830344,1.14946150607232 +-155.46316,57.0114455,13.719616,-88686.3770387803,779315.782514774,267.98974609375,220,2.42811817723738,1.12420215345663 +-155.40207,57.0121613,13.719616,-84982.4103463503,779315.777014968,264.300476074219,220,2.42209794541026,1.10233495311526 +-155.34097,57.0128467,13.719616,-81277.9811629326,779315.77580797,257.051391601562,220,2.41001995935358,1.05846426035698 +-155.27988,57.0135015,13.719616,-77574.2957564532,779315.781280903,250.112182617188,220,2.39813484612699,1.01529413676896 +-155.21878,57.0141257,13.719616,-73870.1357786519,779315.769197501,240.419509887695,220,2.38096970747699,0.952945453773812 +-155.15768,57.0147195,13.719616,-70166.1005845342,779315.773813043,227.812301635742,220,2.35757717184261,0.867977087455324 +-155.09658,57.0152827,13.719616,-66462.1843169015,779315.772522527,205.69450378418,220,2.31322268737731,0.70686893984707 +-155.03548,57.0158154,13.719616,-62758.3805138949,779315.776213151,162.332489013672,121,2.2104054476593,0.333407378229324 +-154.97437,57.0163176,13.719616,-59054.0768870392,779315.775735486,115.468276977539,121,2.06246268530217,-0.20396296172021 +-154.91327,57.0167892,13.719616,-55350.4793938216,779315.778029331,84.9263534545898,22,1.92904247686295,-0.688583240690327 +-154.85216,57.0172303,13.719616,-51646.3695399536,779315.776799869,78.7138214111328,22,1.89605099710569,-0.808417711874531 +-154.79105,57.0176409,13.719616,-47942.3470976906,779315.780726374,68.3123245239258,22,1.83449906370895,-1.03199190264239 +-154.72994,57.0180209,13.719616,-44238.4059306324,779315.778450228,51.6362342834473,22,1.71295456261158,-1.47347622288255 +-154.66882,57.0183704,13.719616,-40533.9336052059,779315.774844497,38.7952919006348,22,1.58877902390247,-1.92451722270146 +-154.60771,57.0186893,13.719616,-36830.1360257767,779315.771344627,27.2138366699219,22,1.43478977394128,-2.48385013146832 +-154.5466,57.0189777,12.82853128,-33126.4007787305,779315.772295718,20.3923454284668,22,1.30946717909158,-2.93905756659226 +-153.99654,57.0201991,11.60265277,209.686715353958,779315.773513082,126.121406555176,22,2.10078880552453,-0.0647515537087983 +-153.56871,57.0194387,11.21181602,26137.877111746,779315.772764708,77.8266296386719,30,1.89112822329188,-0.826298631465805 +-153.5076,57.0192079,13.719616,29841.5117650305,779315.769226834,89.2744598388672,30,1.95072723114475,-0.609818023693736 +-153.44648,57.0189466,13.719616,33545.8029588646,779315.774940589,122.168846130371,30,2.0869604720388,-0.114980007928296 +-153.38537,57.0186547,13.68083784,37249.544995043,779315.769326918,41.439037322998,30,1.61740965768877,-1.82052258879314 +-153.20203,57.0175959,11.5136089,48361.7806127125,779315.776051782,19.5292053222656,30,1.29068457144061,-3.00728135867054 +-153.14092,57.0171819,13.719616,52065.8125651099,779315.778699937,47.4093704223633,30,1.67586418809877,-1.60819904975995 +-153.07981,57.0167373,13.719616,55769.9327814524,779315.77536734,71.4504013061523,30,1.85400467237903,-0.961141964497666 +-153.01871,57.0162622,13.719616,59473.5413553425,779315.768473475,82.802864074707,30,1.9180453588903,-0.728527912056954 +-152.9576,57.0157566,13.719616,63177.8566070079,779315.775600777,87.7793884277344,30,1.9433925507242,-0.636459676507391 +-152.8965,57.0152205,13.719616,66881.6727323976,779315.778524849,98.3338165283203,130,1.99270289531004,-0.457350430398061 +-152.8354,57.0146538,13.719616,70585.6022156419,779315.775300647,123.563461303711,130,2.0918900654116,-0.0970743177522468 +-152.7743,57.0140566,13.719616,74289.6511385532,779315.777361363,149.359954833984,130,2.17423417361165,0.202022986578779 +-152.7132,57.0134288,13.719616,77993.8259738918,779315.773836442,148.370101928711,130,2.17134639504305,0.191533750563559 +-152.65211,57.0127706,13.719616,81697.5265244641,779315.775045016,153.522415161133,130,2.18617179395059,0.24538383098588 +-152.59101,57.0120818,13.719616,85401.9715504261,779315.783033209,147.87580871582,130,2.16989713274914,0.186269616251425 +-152.52992,57.0113625,13.719616,89105.9550285097,779315.784130962,134.90869140625,130,2.13003992971774,0.0414968784630006 +-152.46883,57.0106126,13.719616,92810.089501307,779315.779829314,138.776092529297,130,2.14231465504607,0.0860821844109247 +-152.40775,57.0098323,13.719616,96513.7746872225,779315.778273505,122.321067810059,130,2.08750126362395,-0.113015698533744 +-152.34667,57.0090214,13.719616,100217.623395168,779315.770941789,76.3591079711914,31,1.8828608463134,-0.856328104395967 +-152.28559,57.00818,13.719616,103921.641620261,779315.769383397,73.256591796875,31,1.86484670960232,-0.92176059067713 +-152.22451,57.0073081,13.719616,107625.835614233,779315.774004341,72.182258605957,31,1.85843046714933,-0.94506621464432 +-152.16344,57.0064057,13.719616,111329.60559714,779315.768461543,72.223876953125,31,1.85868079749647,-0.944156943372133 +-152.10237,57.0054728,13.719616,115033.563850234,779315.768838635,78.0336456298828,31,1.89228189705979,-0.82210815904949 +-152.0413,57.0045094,13.719616,118737.716623042,779315.77558566,81.1292572021484,31,1.90917749971155,-0.760738507733175 +-151.98023,57.0035155,13.719616,122442.070164302,779315.789167359,83.092155456543,31,1.91956002495442,-0.723026212583349 +-151.91917,57.002491,13.719616,126146.025040614,779315.77991307,83.4928207397461,31,1.92164913360147,-0.715437973686274 +-151.85812,57.0014361,13.719616,129849.586810045,779315.768954684,80.6710968017578,31,1.90671796163756,-0.769672252039978 +-151.79706,57.0003507,13.719616,133553.974120145,779315.784192411,74.3344192504883,31,1.87118995278209,-0.898720120906373 +-151.73601,56.9992348,13.719616,137257.981154318,779315.786487026,67.8609161376953,31,1.83161971842227,-1.04245050657056 +-151.67497,56.9980884,13.719616,140961.614156993,779315.774703385,75.7151794433594,31,1.87918295595483,-0.869687251952718 +-151.61392,56.9969115,13.719616,144666.091433601,779315.791287756,97.038932800293,134,1.98694601166836,-0.478261074962797 +-151.55289,56.9957041,13.719616,148369.60113377,779315.771457309,136.759948730469,134,2.13595892931322,0.0629963744444772 +-151.49185,56.9944662,13.719616,152073.967591939,779315.781144241,236.344619750977,231,2.37354572028794,0.925979413286249 +-151.43082,56.9931979,13.719616,155777.98455505,779315.786857574,545.969848632812,330,2.7371686593092,2.24676171613128 +-135.08898,55.505779,13.719616,1178082.05425444,779315.851630186,585,450,2.76715586608218,2.35568381033168 +-135.0327,55.4964252,13.719616,1181785.95721355,779315.824971555,535,351,2.72835378202123,2.21474356580488 +-134.97645,55.4870442,13.719616,1185489.7403227,779315.757124364,258,351,2.41161970596323,1.06427499665636 +-134.92022,55.4776361,13.719616,1189194.01069075,779315.836551394,242,251,2.38381536598043,0.963281697690098 +-134.86403,55.4682009,13.719616,1192897.56045781,779315.704392361,230,251,2.36172783601759,0.883053484456362 +-134.80786,55.4587386,13.719616,1196601.60588238,779315.718057532,277,251,2.44247976906445,1.17636755417894 +-134.75172,55.4492492,13.719616,1200305.54512455,779315.69721039,256,251,2.40823996531185,1.05199881393653 +-134.6956,55.4397328,13.719616,1204009.98520824,779315.832556675,200,251,2.30102999566398,0.662581603403571 +-134.63952,55.4301893,13.719616,1207713.72142623,779315.750128035,201,251,2.30319605742049,0.670449357958785 +-134.58346,55.4206188,13.719616,1211417.96680442,779315.822494547,196,151,2.29225607135648,0.630712205991387 +-134.52744,55.4110214,13.719616,1215121.51020352,779315.694805351,191,151,2.28103336724773,0.589948141389748 +-134.47144,55.4013969,13.719616,1218825.57425209,779315.70987202,192,151,2.28330122870355,0.598185661509398 +-134.41547,55.3917455,13.719616,1222529.55060234,779315.705374216,184,151,2.26481782300954,0.531048656339518 +-134.35952,55.3820671,13.719616,1226234.0526303,779315.854066514,183,151,2.26245108973043,0.522452005536869 +-134.30361,55.3723618,13.719616,1229937.8691388,779315.79665549,176,151,2.24551266781415,0.460926822429992 +-134.24773,55.3626296,13.719616,1233641.61024653,779315.716008224,176,151,2.24551266781415,0.460926822429992 +-134.19187,55.3528706,13.719616,1237345.88279357,779315.807876619,158,151,2.19865708695442,0.290733978833201 +-134.13604,55.3430846,13.719616,1241050.0913628,779315.864561379,150.305816650391,151,2.17697578757485,0.211981311027644 +-134.08025,55.3332719,13.719616,1244753.6241485,779315.729365391,144.230117797852,151,2.15905595821734,0.146891375972623 +-134.02448,55.3234322,13.719616,1248457.70712404,779315.743476167,130.773773193359,151,2.11652065454269,-0.00760898775807683 +-133.96874,55.3135658,13.719616,1252161.7284192,779315.750751871,120.800788879395,151,2.08206977041797,-0.132744432160366 +-133.91303,55.3036727,13.719616,1255865.69203515,779315.750001834,111.955192565918,151,2.04904424128644,-0.252702580390566 +-133.85735,55.2937527,13.719616,1259569.60862027,779315.718785217,105.81714630127,151,2.02455604521037,-0.341650698165886 +-133.80169,55.283806,13.719616,1263274.08157837,779315.867415803,111.64070892334,151,2.04782258561413,-0.257139982487652 +-133.74607,55.2738326,13.719616,1266977.90283207,779315.81484187,100.746284484863,151,2.00322903836177,-0.419116474373813 +-133.69048,55.2638324,13.5605648,1270681.68574428,779315.738944871,73.6150665283203,50,1.86696670890907,-0.914060148086989 +-133.57938,55.2437521,13.42332545,1278089.74171661,779315.758129542,132.976913452148,50,2.12377624825549,0.0187453995594472 +-133.52387,55.233672,13.719616,1281794.02267165,779315.852028399,152.0068359375,151,2.18186311914989,0.229733494291509 +-133.4684,55.2235652,10.84412723,1285497.67174418,779315.736193827,45.9058303833008,50,1.66186784768301,-1.65903775310326 +-133.35754,55.2032719,12.06746421,1292905.50054141,779315.685275113,27.2040367126465,50,1.4346333522677,-2.48441829963396 +-133.30215,55.1930853,13.52384072,1296609.69149596,779315.738454161,85.2327880859375,50,1.93060669506624,-0.682901553703641 +-133.24679,55.1828723,12.31362914,1300313.8620472,779315.802778294,92.3998413085938,50,1.96567122534499,-0.555537171317885 +-156.74281,56.9562054,13.40485346,-166470.418593036,775611.789102709,32.7478370666504,20,1.5151826209373,-2.19184036477573 +-156.68185,56.9575605,13.57887813,-162766.478708858,775611.789697328,30.3897380828857,20,1.48272695708397,-2.30972859965977 +-156.62088,56.9588851,13.719616,-159062.206796421,775611.770769908,19.0672874450684,20,1.28028891373659,-3.04504135466766 +-156.55991,56.9601794,13.719616,-155358.202349944,775611.779053674,72.1228103637695,20,1.85807264125748,-0.946365940417204 +-156.49894,56.9614431,13.719616,-151654.460454991,775611.78047077,80.3176040649414,20,1.90481074466032,-0.776599808475231 +-156.43796,56.9626765,13.719616,-147950.367026858,775611.785592215,77.627067565918,20,1.89001318059863,-0.830348784792586 +-156.37697,56.9638793,13.719616,-144245.917087592,775611.762040143,83.0591201782227,20,1.91938732643956,-0.723653502882367 +-156.31599,56.9650517,13.719616,-140542.316767142,775611.775539586,115.267272949219,121,2.06170601852542,-0.206711391427566 +-156.255,56.9661937,13.719616,-136838.346679335,775611.782644481,168.692291259766,121,2.22709523706548,0.394029457092726 +-156.194,56.9673052,13.719616,-133134.000983103,775611.773324832,163.513580322266,121,2.21355382803054,0.344843194374885 +-156.13301,56.9683862,13.719616,-129430.486614491,775611.787697068,169.37532043457,121,2.22885012984407,0.400403728560827 +-156.072,56.9694367,13.719616,-125725.977565098,775611.76677272,215.918960571289,220,2.33429078087025,0.783394268845986 +-156.011,56.9704568,13.719616,-122022.287019989,775611.779668851,219.838302612305,220,2.34210336217278,0.811771794069505 +-155.94999,56.9714464,13.719616,-118318.195916126,775611.777434086,254.426254272461,220,2.40556192418292,1.04227140416722 +-155.88898,56.9724055,13.719616,-114614.304597368,775611.778523147,306.664611816406,220,2.48666366258311,1.33685606677751 +-155.82796,56.9733341,13.719616,-110910.000229351,775611.765773355,294.79150390625,220,2.46951496270193,1.27456709408277 +-155.76695,56.9742323,13.719616,-107206.489446152,775611.78385267,292.276397705078,220,2.46579374604403,1.26105057304032 +-155.70592,56.9751,13.719616,-103501.946551858,775611.772743787,289.015380859375,220,2.46092095571366,1.2433512077276 +-155.6449,56.9759372,13.719616,-99798.1850646699,775611.780457022,282.871978759766,220,2.45158992846532,1.2094582534213 +-155.58387,56.9767439,13.719616,-96093.9855585403,775611.77597646,278.300964355469,220,2.44451471123355,1.18375904496744 +-155.52284,56.9775201,13.719616,-92389.948372865,775611.774498352,273.016906738281,220,2.43618954182388,1.1535196534316 +-155.46181,56.9782658,13.719616,-88686.0672576772,775611.775648509,269.827209472656,220,2.4310857419556,1.13498119554048 +-155.40078,56.978981,13.719616,-84982.3359623776,775611.779067494,263.9736328125,220,2.42156054923378,1.10038297681416 +-155.33974,56.9796657,13.719616,-81278.1416470551,775611.772171829,255.080047607422,220,2.40667648937072,1.0463198230579 +-155.2787,56.9803199,13.719616,-77574.0846486322,775611.767985556,245.594604492188,220,2.39021882148782,0.986540875821108 +-155.21766,56.9809437,13.719616,-73870.1585101513,775611.777351946,235.794052124023,220,2.37253284587232,0.922300364305599 +-155.15662,56.9815369,13.719616,-70166.3573982381,775611.777653042,221.344635009766,220,2.34506899993632,0.82254383690397 +-155.09557,56.9820996,13.719616,-66462.0682559346,775611.769753602,186.594131469727,121,2.2708979807267,0.553133524618057 +-155.03453,56.9826319,13.719616,-62758.4978329529,775611.785114679,142.289337158203,121,2.15317235625533,0.12552045429941 +-154.97348,56.9831336,13.719616,-59054.4270555294,775611.781703597,89.7523345947266,121,1.95304575405727,-0.601396486703143 +-154.91243,56.9836048,13.719616,-55350.4560735271,775611.780445198,80.2645111083984,22,1.90452356474779,-0.77764292788685 +-154.85137,56.9840455,13.719616,-51645.9720431006,775611.773335486,80.1256790161133,22,1.90377172292253,-0.780373831993233 +-154.79032,56.9844557,13.719616,-47942.1818861446,775611.77627313,62.1232795715332,22,1.79325437465188,-1.18180438570395 +-154.72927,56.9848354,13.719616,-44238.4727580821,775611.780725824,52.0745735168457,22,1.71662572182595,-1.4601415247628 +-154.66821,56.9851846,13.719616,-40534.2318140081,775611.780406861,39.9008560180664,22,1.60098221297835,-1.88019175684093 +-154.60715,56.9855032,13.719616,-36830.0594881634,775611.771206686,27.2644176483154,22,1.43559622585104,-2.48092086794777 +-153.99654,56.9870117,13.494714,209.879692629387,775611.778036877,137.021469116211,22,2.13678861962508,0.0660100464743355 +-153.87442,56.9869472,5.602626883,7617.55005880247,775611.77615459,18.6491603851318,22,1.27065928395637,-3.08001891859938 +-153.50805,56.9860214,13.71551108,29841.6772576926,775611.777566881,126.303298950195,30,2.10141469415909,-0.0624781475416597 +-153.44699,56.9857603,13.719616,33545.737416625,775611.778030853,100.840553283691,30,2.00363521986235,-0.417641107227964 +-153.38593,56.9854687,13.71742809,37249.8542754586,775611.780495959,40.798641204834,30,1.61064569919112,-1.84509121668257 +-153.32487,56.9851465,12.57930325,40954.0342046536,775611.773942803,16.2985992431641,30,1.21215028126868,-3.2925403164931 +-153.26382,56.9847939,13.18505971,44657.6766555951,775611.774122507,23.7797660827637,30,1.37620757822781,-2.696637387323 +-153.20276,56.9844108,13.719616,48362.0011653649,775611.782936194,42.0999984741211,30,1.62428208009503,-1.79555998902895 +-153.14171,56.9839971,13.719616,52065.8009569462,775611.775402292,81.062744140625,30,1.90882130141602,-0.762032321611654 +-153.08066,56.9835529,13.719616,55769.6887511564,775611.769604745,120.871681213379,130,2.08232456278493,-0.131818953558592 +-153.01961,56.9830783,13.719616,59473.6706387245,775611.776917148,115.160850524902,130,2.06130486371653,-0.208168500194435 +-152.95856,56.9825731,13.719616,63177.7531939889,775611.775249513,132.431701660156,130,2.12199195948479,0.0122643534575329 +-152.89751,56.9820374,13.719616,66881.9425171445,775611.776005004,128.164367675781,130,2.10776729918624,-0.0394036728690723 +-152.83647,56.9814712,13.719616,70585.6382737415,775611.768813314,125.183074951172,130,2.09754561519878,-0.0765317466705964 +-152.77542,56.9808746,13.719616,74290.0596892096,775611.78580568,144.716781616211,130,2.16051889560229,0.152205182118695 +-152.71438,56.9802474,13.719616,77994.0002407607,775611.783137271,145.378234863281,130,2.16249939148641,0.159398908459606 +-152.65334,56.9795897,13.719616,81698.0725743883,775611.782897984,151.285186767578,130,2.17979640574922,0.222226601321526 +-152.59231,56.9789015,13.719616,85401.6763536605,775611.772545346,157.165252685547,130,2.19635653511958,0.282377717926183 +-152.53127,56.9781828,13.719616,89106.0310077101,775611.777572575,147.746917724609,130,2.16951842945748,0.184894057803419 +-152.47024,56.9774337,13.719616,92809.9293532051,775611.783206816,137.3427734375,130,2.13780581309198,0.0697047834820366 +-152.40921,56.976654,13.719616,96513.9847332359,775611.7803534,108.921287536621,130,2.03711276640594,-0.296041102738524 +-152.34819,56.9758438,13.719616,100217.596562192,775611.76545544,76.5443878173828,31,1.88391335402459,-0.852505095973339 +-152.28716,56.9750032,13.719616,103921.983978902,775611.779683567,73.4525909423828,31,1.86600711955628,-0.917545650510377 +-152.22614,56.9741321,13.719616,107625.94032182,775611.781546797,71.5023574829102,31,1.85432036103102,-0.959995293207122 +-152.16512,56.9732305,13.719616,111330.078427492,775611.786555482,77.7917938232422,31,1.89093378612526,-0.827004882752885 +-152.10411,56.9722984,13.719616,115033.797954324,775611.777822605,76.8497161865234,31,1.88564226794696,-0.846225187126108 +-152.0431,56.9713358,13.719616,118737.711737367,775611.772003331,80.6498718261719,31,1.90660368151753,-0.770087350054703 +-151.98209,56.9703428,13.719616,122441.825683128,775611.78071674,82.4104537963867,31,1.91598230560636,-0.736021510438272 +-151.92109,56.9693192,13.719616,126145.540115526,775611.763135671,82.1002578735352,31,1.9143445212227,-0.741970410789925 +-151.86008,56.9682652,13.719616,129850.073767528,775611.779495124,76.4951934814453,31,1.88363414744034,-0.853519253980812 +-151.79909,56.9671808,13.719616,133553.613085335,775611.771644481,63.6854438781738,31,1.80404018012533,-1.142627261649 +-151.73809,56.9660659,13.719616,137257.984426553,775611.787608416,62.1351852416992,31,1.79333759742274,-1.18150209684604 +-151.6771,56.9649205,13.719616,140961.980855035,775611.787145805,90.5165786743164,31,1.95672813022584,-0.588021045404094 +-151.61612,56.9637446,13.719616,144665.608611107,775611.769135013,120.602554321289,134,2.0813565061117,-0.135335211706627 +-151.55513,56.9625383,13.719616,148370.08670079,775611.788304119,160.312316894531,134,2.20496689074987,0.313652987215562 +-151.49416,56.9613015,13.719616,152073.601986629,775611.767056963,305.399658203125,231,2.48486854666742,1.33033569339463 +-151.43318,56.9600343,13.719616,155777.980040876,775611.784164365,694.026306152344,330,2.84137593212673,2.62527227472143 +-135.04921,55.4645215,13.719616,1181785.83645554,775611.78569921,423,450,2.62634036737504,1.8442017262825 +-134.993,55.4551481,13.719616,1185489.82919416,775611.788324446,507,450,2.70500795933334,2.12994487424125 +-134.93682,55.4457475,13.719616,1189193.70254709,775611.745774618,423,351,2.62634036737504,1.8442017262825 +-134.88066,55.4363199,13.719616,1192898.06100626,775611.857750066,274,251,2.43775056282039,1.15918972725066 +-134.82454,55.4268652,13.719616,1196601.69873553,775611.753589836,240,251,2.38021124171161,0.950190489626241 +-134.76844,55.4173834,13.719616,1200305.83310326,775611.791820981,221,251,2.34439227368511,0.820085774002676 +-134.71237,55.4078745,13.719616,1204009.86170617,775611.79155054,202,251,2.30535136944662,0.678278066425006 +-134.65633,55.3983387,13.719616,1207713.78232673,775611.772856009,198,251,2.29666519026153,0.646727384342376 +-134.60032,55.3887759,13.719616,1211417.60229329,775611.723799683,196,151,2.29225607135648,0.630712205991387 +-134.54433,55.379186,13.719616,1215121.93555325,775611.815432811,196,151,2.29225607135648,0.630712205991387 +-134.48838,55.3695692,13.719616,1218825.56664142,775611.70245727,191,151,2.28103336724773,0.589948141389748 +-134.43245,55.3599255,13.719616,1222529.71283943,775611.750122636,191,151,2.28103336724773,0.589948141389748 +-134.37655,55.3502549,13.719616,1226233.7716573,775611.774219028,193,151,2.28555730900777,0.60638038912377 +-134.32068,55.3405573,13.719616,1229937.7504406,775611.762861533,188,151,2.27415784926368,0.564974297603475 +-134.26484,55.3308329,13.719616,1233641.64678127,775611.736133042,184,151,2.26481782300954,0.531048656339518 +-134.20902,55.3210815,13.719616,1237346.0778638,775611.857830554,178,151,2.25042000230889,0.478751662007618 +-134.15324,55.3113034,13.719616,1241049.82477696,775611.786609548,167,151,2.22271647114758,0.378124529454699 +-134.09749,55.3014984,13.719616,1244753.50470312,775611.68572727,172,151,2.23552844690755,0.42466128231685 +-134.04176,55.2916666,13.719616,1248457.72499975,775611.752616382,150.306594848633,151,2.17697803609946,0.211989478310814 +-133.98606,55.281808,13.719616,1252161.88311153,775611.799206975,132.64094543457,151,2.12267760876978,0.0147548273644163 +-133.93039,55.2719227,13.719616,1255865.97975177,775611.834942589,116.501564025879,151,2.06633175577619,-0.189909393415899 +-133.87475,55.2620106,13.719616,1259570.02223963,775611.848004124,114.762588500977,151,2.059800335313,-0.213633376791216 +-133.81914,55.2520718,13.719616,1263274.01125962,775611.847843996,118.109451293945,151,2.0722846518944,-0.168286775588849 +-133.76356,55.2421062,13.719616,1266977.95413757,775611.822663653,109.187309265137,151,2.03817216367633,-0.292193069470407 +-133.70801,55.232114,13.719616,1270681.84817921,775611.792544617,103.206428527832,151,2.01370674949286,-0.381058436909193 +-133.65249,55.2220951,13.70978891,1274385.70069043,775611.745699907,90.9564514160156,50,1.95883350840235,-0.580373710932246 +-133.597,55.2120496,13.68035857,1278089.51227168,775611.691590432,83.0723114013672,50,1.91945629442929,-0.723402991458253 +-133.54153,55.2019774,13.719616,1281793.89682414,775611.811458625,125.046447753906,151,2.09707135905901,-0.0782543803364102 +-133.4861,55.1918786,13.719616,1285497.6417421,775611.729313373,64.3115692138672,50,1.8082891065756,-1.12719394801728 +-133.43069,55.1817532,13.719616,1289201.96412793,775611.830589662,72.7868576049805,50,1.86205297017989,-0.931908249672043 +-133.37532,55.1716012,13.719616,1292905.6547236,775611.726462263,53.633861541748,50,1.72943906651181,-1.41359979957105 +-133.31997,55.1614227,13.719616,1296609.92720877,775611.81521079,79,50,1.89762709129044,-0.802692887933441 +-133.26466,55.1512177,13.71854908,1300313.57228794,775611.705784149,85,50,1.92941892571429,-0.687215871013048 +-133.20937,55.1409861,6.081748122,1304017.81044408,775611.777504961,14.3625831604004,50,1.15723255630024,-3.49201716865777 +-133.15411,55.1307281,3.413604785,1307722.03210978,775611.855208381,45.5956153869629,50,1.65892308159422,-1.66973398405768 +-156.92298,56.9187997,10.81789857,-177582.376152694,771907.781501904,21.0281867980957,20,1.32280182629873,-2.89062232184864 +-156.86209,56.9202449,9.582299203,-173878.438768686,771907.789589055,97.3226089477539,20,1.98821374263883,-0.473656314231634 +-156.74029,56.9230439,13.64106417,-166470.221481325,771907.771588887,72.2889633178711,20,1.85907199665793,-0.942735996358327 +-156.67938,56.9243979,13.719616,-162765.928241444,771907.768689868,35.5404434204102,20,1.55072284197902,-2.06274813776319 +-156.61847,56.9257214,13.719616,-159061.909196691,771907.767857837,82.4110870361328,20,1.91598564270084,-0.736009389158601 +-156.55756,56.9270144,13.719616,-155358.158115899,771907.768456526,65.2901458740234,20,1.81484763892477,-1.1033714865336 +-156.49664,56.9282771,13.719616,-151654.060781479,771907.769332754,139.471542358398,121,2.14448560361328,0.0939676892574507 +-156.43572,56.9295093,13.719616,-147950.21898638,771907.771528012,95.8186187744141,121,1.9814499062114,-0.498224498727163 +-156.37479,56.9307111,13.719616,-144246.018950837,771907.763882395,173.449310302734,121,2.23917257726939,0.437897803929414 +-156.31386,56.9318825,13.719616,-140542.061616652,771907.768654747,156.039123535156,121,2.19323350223374,0.271033971082485 +-156.25293,56.9330235,13.719616,-136838.340778201,771907.7852828,173.95881652832,121,2.24044644442346,0.442524853030902 +-156.19199,56.934134,13.719616,-133134.243450758,771907.782017844,180.557510375977,121,2.25661555782519,0.501255688030409 +-156.13105,56.935214,13.719616,-129430.370542559,771907.779488152,183.543685913086,121,2.26373944893115,0.527131693888198 +-156.0701,56.9362636,13.719616,-125726.108320239,771907.769397195,212.896301269531,220,2.32816811633646,0.761155003676835 +-156.00915,56.9372828,13.719616,-122022.057720961,771907.77128797,210.435684204102,220,2.32311938633191,0.742816575249288 +-155.9482,56.9382715,13.719616,-118318.212861934,771907.773515746,267.616973876953,220,2.42751365553568,1.12200635808835 +-155.88724,56.9392298,13.719616,-114613.960037934,771907.769502006,305.965179443359,220,2.48567200414145,1.3332540802699 +-155.82629,56.9401576,13.719616,-110910.507636956,771907.782704943,300.464691162109,220,2.47779344361187,1.3046368996614 +-155.76532,56.941055,13.719616,-107206.027679782,771907.773732435,292.495788574219,220,2.46611961738523,1.26223423076448 +-155.70436,56.9419219,13.719616,-103502.335678839,771907.781098675,288.308471679688,220,2.45985740392024,1.23948808404598 +-155.64339,56.9427583,13.719616,-99798.2110964894,771907.772658415,283.660430908203,220,2.45279875829586,1.21384906840019 +-155.58242,56.9435643,13.719616,-96094.254567839,771907.775308809,274.839874267578,220,2.43907974118997,1.16401768247426 +-155.52145,56.9443398,13.719616,-92390.4601331362,771907.777505356,276.181030273438,220,2.44119384538492,1.17169671233573 +-155.46047,56.9450849,13.719616,-88686.214153753,771907.77667798,270.206024169922,220,2.43169502727147,1.13719429371506 +-155.39949,56.9457995,13.719616,-84982.1177946147,771907.775780573,261.262908935547,220,2.41707775803192,1.08410019965299 +-155.33851,56.9464836,13.719616,-81278.1648077097,771907.774469025,253.018402099609,220,2.40315210868444,1.03351826644691 +-155.27753,56.9471373,13.719616,-77574.3487297695,771907.783572004,243.222457885742,220,2.38600367292616,0.971230253121982 +-155.21654,56.9477604,13.719616,-73870.0566047924,771907.769335529,228.861465454102,220,2.35957267450297,0.875225322690902 +-155.15556,56.9483531,13.719616,-70166.4960568949,771907.77658,209.868713378906,220,2.32194770004191,0.738560676211456 +-155.09457,56.9489154,13.719616,-66462.4465737469,771907.78333188,169.332473754883,121,2.228740252971,0.400004624395846 +-155.03358,56.9494471,13.719616,-62758.5094292485,771907.778126369,107.29419708252,121,2.03057623414498,-0.319783653622404 +-154.97258,56.9499484,13.719616,-59054.0708682272,771907.774132621,79.3873672485352,22,1.899751399521,-0.794976794102113 +-154.91159,56.9504192,13.719616,-55350.3391159665,771907.778292692,69.2491226196289,22,1.84041427529797,-1.0105061657816 +-154.85059,56.9508595,13.719616,-51646.0936276378,771907.773153056,64.2980041503906,22,1.80819749236552,-1.1275267169776 +-154.78959,56.9512693,13.719616,-47941.9352973635,771907.767393836,53.0391883850098,22,1.72459686979701,-1.43118804013976 +-154.7286,56.9516487,13.719616,-44238.4648964848,771907.778638422,46.3413734436035,22,1.66596890105817,-1.64414155668754 +-154.6676,56.9519976,13.719616,-40534.4620220471,771907.78166445,36.2193298339844,22,1.55894041030451,-2.03289958407747 +-154.60659,56.952316,13.719616,-36829.9204207543,771907.77797705,29.2742538452148,22,1.46648583440074,-2.36872099292318 +-154.54559,56.9526039,13.719616,-33126.0481319186,771907.779072124,21.6952133178711,22,1.33636392468043,-2.84136090951802 +-154.48459,56.9528613,13.719616,-29422.2317552688,771907.778707452,18.2094402313232,22,1.2602965955377,-3.11765916074177 +-154.42359,56.9530882,13.22576196,-25718.4650367524,771907.776759005,12.0921573638916,22,1.08250379032724,-3.76345337638506 +-154.05755,56.9538096,13.56669115,-3494.12866323533,771907.780411329,30.6778926849365,22,1.48682552389702,-2.29484143514734 +-153.99654,56.9538231,13.20401092,210.072670113215,771907.77856068,66.1205139160156,22,1.82033622042909,-1.08343539191277 +-153.87453,56.9537586,11.97528432,7617.87552199034,771907.770925576,24.4189586639404,22,1.38772713970111,-2.65479505204177 +-153.69151,56.9534333,3.203021754,18729.9954220852,771907.772396751,11.4115514755249,30,1.05734469362537,-3.85483839672739 +-153.5695,56.953064,11.23121385,26138.0205976682,771907.773840217,32.9965515136719,30,1.51846855391301,-2.17990491830931 +-153.5085,56.9528336,13.719616,29841.7926674147,771907.770581538,129.876266479492,30,2.11352979557869,-0.0184726411914475 +-153.4475,56.9525728,13.719616,33545.6150201362,771907.776912326,132.922836303711,30,2.12359959966888,0.0181037614723503 +-153.3865,56.9522814,13.719616,37249.4940852995,771907.77063848,49.9223098754883,30,1.69829467168579,-1.52672513107448 +-153.32549,56.9519596,13.719616,40954.0430672105,771907.780386699,28.6366500854492,30,1.45692221285038,-2.40345879612347 +-153.26449,56.9516073,13.719616,44658.0540193697,771907.783376493,33.3684959411621,30,1.52333663161209,-2.16222267061852 +-153.2035,56.9512245,13.719616,48361.533195045,771907.778104379,74.1567764282227,30,1.87015084290204,-0.902494464582175 +-153.1425,56.9508112,13.719616,52065.7011400841,771907.778761417,158.942184448242,130,2.20123917752005,0.300112868769576 +-153.0815,56.9503674,13.719616,55769.9569606783,771907.778822287,120.80477142334,130,2.08208408794326,-0.132692426821895 +-153.02051,56.9498931,13.719616,59473.6997626566,771907.76954536,137.008514404297,130,2.13674755725788,0.0658608962363106 +-152.95952,56.9493884,13.719616,63177.5427695177,771907.770157879,128.163070678711,130,2.10776290419307,-0.0394196367387292 +-152.89853,56.9488532,13.719616,66881.4923871012,771907.769743812,122.697578430176,130,2.08883599153882,-0.108167585777657 +-152.83754,56.9482875,13.719616,70585.5548664647,771907.76856094,129.653305053711,130,2.11278359205249,-0.0211830653863108 +-152.77655,56.9476914,13.719616,74289.7362526303,771907.778040044,135.638412475586,130,2.13238269811337,0.0500064819686007 +-152.71556,56.9470647,13.719616,77994.043196641,771907.776151485,141.027709960938,130,2.14930445379558,0.111471128556328 +-152.65458,56.9464076,13.719616,81697.8743802561,771907.773211601,148.049438476562,130,2.17040676453185,0.188120744349617 +-152.5936,56.9457201,13.719616,85401.8431682674,771907.780722572,160.279937744141,130,2.20487916507223,0.313334342514994 +-152.53262,56.945002,13.719616,89105.9562716058,771907.776699972,165.980865478516,130,2.22005802481071,0.368468293563037 +-152.47165,56.9442535,13.719616,92809.6123088812,771907.769829587,148.797058105469,130,2.17259434477712,0.196066660198006 +-152.41067,56.9434745,13.719616,96514.0320566506,771907.776706537,115.017807006836,130,2.0607650828417,-0.210129138400638 +-152.3497,56.9426651,13.719616,100218.007191431,771907.78035472,77.1598739624023,31,1.88739150956959,-0.839871442269446 +-152.28874,56.9418252,13.719616,103921.54421609,771907.768333425,72.3257522583008,31,1.85929295942932,-0.941933396503605 +-152.22777,56.9409549,13.719616,107625.863371103,771907.782941906,75.2224197387695,31,1.87634729960343,-0.879987165197899 +-152.16681,56.940054,13.719616,111329.75719356,771907.770432337,81.3802108764648,31,1.91051881088427,-0.755866482705558 +-152.10585,56.9391228,13.719616,115033.838149775,771907.780354099,80.4475708007812,31,1.90551293465327,-0.774049253995868 +-152.0449,56.9381611,13.719616,118737.505932036,771907.772963933,81.6470642089844,31,1.9119405733867,-0.75070223548528 +-151.98394,56.9371689,13.719616,122441.981075624,771907.783925355,82.5931396484375,31,1.91694397544917,-0.732528451081275 +-151.92299,56.9361463,13.719616,126146.055180251,771907.788554259,82.5187301635742,31,1.91655253622797,-0.733950270060553 +-151.86205,56.9350932,13.719616,129849.734815169,771907.774514261,72.7972106933594,31,1.86211473915246,-0.931683887133024 +-151.80111,56.9340097,13.719616,133553.632997265,771907.771902932,64.5592498779297,31,1.80995847562095,-1.12113032315922 +-151.74017,56.9328957,13.719616,137257.756314517,771907.770086954,78.4407272338867,31,1.89454161141339,-0.813900231530527 +-151.67924,56.9317514,13.719616,140961.50307876,771907.770682946,120.807495117188,134,2.08209387954221,-0.132656860939684 +-151.61831,56.9305765,13.719616,144665.487812635,771907.760890899,151.013473510742,134,2.17901569703041,0.219390844418364 +-151.55738,56.9293713,13.719616,148369.715551924,771907.774734277,206.998443603516,134,2.31596708006104,0.716837357402052 +-151.49646,56.9281356,13.719616,152073.58616523,771907.767587501,471.315277099609,231,2.67331151710428,2.01481434899999 +-134.95339,55.4138552,13.719616,1189193.51016771,771907.697567837,660,450,2.81954393554187,2.54597223165299 +-134.89727,55.404435,13.719616,1192898.07393171,771907.853257738,635,450,2.80277372529198,2.48505804133082 +-134.84119,55.3949879,13.719616,1196601.90633966,771907.811465748,567,450,2.75358305889291,2.30638350055537 +-134.78514,55.3855137,13.719616,1200305.62503089,771907.728605399,396,351,2.59769518592551,1.74015425110902 +-134.72911,55.3760124,13.719616,1204009.84133716,771907.784697109,224,251,2.35024801833416,0.841355509963957 +-134.67311,55.3664842,13.719616,1207713.94590005,771907.819631308,192,251,2.28330122870355,0.598185661509398 +-134.61714,55.356929,13.719616,1211417.946045,771907.821463393,201,251,2.30319605742049,0.670449357958785 +-134.5612,55.3473468,13.719616,1215121.84591398,771907.788932094,193,151,2.28555730900777,0.60638038912377 +-134.50529,55.3377377,13.719616,1218825.64642075,771907.731445314,195,151,2.29003461136252,0.622643229225523 +-134.4494,55.3281017,13.719616,1222529.95881593,771907.831833956,185,151,2.26717172840301,0.539598712600118 +-134.39355,55.3184387,13.719616,1226233.5761459,771907.710582818,196,151,2.29225607135648,0.630712205991387 +-134.33772,55.3087489,13.719616,1229937.71032454,771907.756495304,188,151,2.27415784926368,0.564974297603475 +-134.28192,55.2990321,13.719616,1233641.76478313,771907.762946239,189,151,2.27646180417324,0.573342919449214 +-134.22615,55.2892886,13.719616,1237345.73382874,771907.760661425,179,151,2.25285303097989,0.487589116596209 +-134.17041,55.2795182,13.719616,1241049.628037,771907.727118926,165,151,2.21748394421391,0.359118498119706 +-134.11469,55.269721,13.719616,1244754.05534044,771907.859182858,162,151,2.20951501454263,0.330173070994654 +-134.05901,55.259897,13.719616,1248457.80548516,771907.78133746,165,151,2.21748394421391,0.359118498119706 +-134.00336,55.2500462,13.719616,1252161.48965104,771907.67925415,146,151,2.16435285578444,0.166131219821422 +-133.94773,55.2401687,13.719616,1255865.71570084,771907.751475077,129.833709716797,151,2.11338746629553,-0.0189896217727313 +-133.89213,55.2302645,13.719616,1259569.88048393,771907.80881427,119.53670501709,151,2.0775012805037,-0.149338491505833 +-133.83656,55.2203335,13.719616,1263273.99131998,771907.839455857,112.834121704102,151,2.05244045272287,-0.240366571078201 +-133.78102,55.2103758,13.719616,1266978.04888212,771907.852850377,115.8779296875,151,2.06400072735562,-0.198376353981166 +-133.72551,55.2003915,13.719616,1270682.05380263,771907.858443915,125.706977844238,151,2.09935938552318,-0.0699436151507847 +-133.67003,55.1903805,13.719616,1274386.01338457,771907.84444245,157.904312133789,151,2.19839399011177,0.28977833600537 +-133.61458,55.1803429,13.719616,1278089.9282315,771907.820300632,136,151,2.13353890837022,0.0542061676367513 +-133.55916,55.1702786,13.719616,1281793.80565309,771907.774244727,72,50,1.85733249643127,-0.949054357684372 +-133.50377,55.1601878,13.719616,1285497.6428419,771907.726346686,151,151,2.17897694729317,0.219250094312423 +-133.4484,55.1500704,13.719616,1289202.05423418,771907.858968663,56,50,1.7481880270062,-1.34549822356933 +-133.39307,55.1399264,13.719616,1292905.82945664,771907.783278718,125,50,2.09691001300806,-0.0788404352462293 +-133.33777,55.1297559,13.719616,1296609.57616116,771907.702310167,139.279739379883,50,2.14388794545861,0.0917968242510626 +-133.28249,55.1195589,13.719616,1300313.90537636,771907.810725393,152.973571777344,50,2.18461640714004,0.239734222138368 +-133.22725,55.1093354,9.690209938,1304017.60668596,771907.716358138,19.8184566497803,50,1.29706983104826,-2.98408827324102 +-156.98113,56.8841666,13.71566709,-181286.298915225,768203.785385336,32.408634185791,20,1.51066072871585,-2.20826516800056 +-156.9203,56.8856408,13.719616,-177582.327053669,768203.780425607,42.7520904541016,20,1.63095735533283,-1.77131348405201 +-156.85946,56.8870847,13.45715558,-173878.045115204,768203.770614387,70.9761352539062,20,1.85111234773631,-0.971647713151656 +-156.79862,56.8884982,13.18819501,-170174.055111954,768203.771409447,33.4991226196289,20,1.52503343251614,-2.15605940541982 +-156.73778,56.8898813,13.71908548,-166470.350849924,768203.782133651,144.646331787109,20,2.16030742446989,0.151437058605915 +-156.67693,56.891234,13.719616,-162766.318429787,768203.777615407,36.1736488342285,20,1.55839231823481,-2.03489041091567 +-156.61607,56.8925564,13.719616,-159061.951215791,768203.770030634,39.5148162841797,20,1.59675996711916,-1.89552815895043 +-156.55522,56.8938483,13.719616,-155358.459308118,768203.78490437,59.6059494018555,20,1.77528960979804,-1.24705753930749 +-156.49435,56.8951099,13.719616,-151654.012527036,768203.773739301,87.4358139038086,121,1.94168935706155,-0.642646162030007 +-156.43349,56.896341,13.719616,-147950.428633911,768203.783808042,139.284896850586,121,2.14390402690454,0.0918552366527675 +-156.37262,56.8975417,13.719616,-144246.485590603,768203.780558072,163.226425170898,121,2.21279046922721,0.342070457316898 +-156.31174,56.8987121,13.719616,-140542.176807208,768203.776239783,185.658157348633,121,2.26871403577962,0.545200813210314 +-156.25086,56.899852,13.719616,-136838.104572417,768203.770264702,182.99201965332,121,2.26243215040749,0.522383212510123 +-156.18998,56.9009615,13.719616,-133134.262284186,768203.773238672,190.585113525391,121,2.28008897517815,0.586517839836715 +-156.12909,56.9020406,13.719616,-129430.036033966,768203.76514038,191.497543334961,121,2.28216320690561,0.594052041515533 +-156.0682,56.9030893,13.719616,-125726.027320681,768203.766057004,210.826736450195,220,2.32392568603048,0.745745285895349 +-156.00731,56.9041076,13.719616,-122022.229938194,768203.775485548,216.305160522461,220,2.33506688078765,0.786213285266976 +-155.94641,56.9050955,13.719616,-118318.029975336,768203.775121522,265.226135253906,220,2.42361631700764,1.10785011214336 +-155.88551,56.9060529,13.719616,-114614.029245275,768203.772267343,292.10986328125,220,2.46554622145934,1.26015149309819 +-155.82461,56.9069799,13.719616,-110910.221202144,768203.777618236,304.360473632812,220,2.48338825125962,1.32495883795513 +-155.7637,56.9078765,13.719616,-107205.991932369,768203.774586609,292.151184082031,220,2.4656076508354,1.26037462212572 +-155.70279,56.9087426,13.719616,-103501.943216101,768203.768844512,285.442474365234,220,2.45551859740493,1.22372830036372 +-155.64188,56.9095783,13.719616,-99798.0685359063,768203.771131783,281.179260253906,220,2.44898328402396,1.19999017679987 +-155.58097,56.9103836,13.719616,-96094.3616802202,768203.781047389,277.212036132812,220,2.44281208276727,1.17757461239936 +-155.52005,56.9111584,13.719616,-92390.2089880218,768203.773136127,272.872772216797,220,2.43596020307211,1.15268662962539 +-155.45913,56.9119028,13.719616,-88686.2116747306,768203.773209805,267.302673339844,220,2.4270033022318,1.12015260921932 +-155.39821,56.9126168,13.719616,-84982.3635268271,768203.78091111,259.960693359375,220,2.41490768663381,1.07621788093504 +-155.33728,56.9133003,13.719616,-81278.0508507116,768203.772501128,246.71159362793,220,2.39218955861146,0.993699155558522 +-155.27636,56.9139534,13.719616,-77574.4825948863,768203.783843858,232.199432373047,220,2.36586115374211,0.89806687419815 +-155.21543,56.914576,13.719616,-73870.4373399642,768203.779548274,219.441268920898,220,2.34131830591506,0.8089202456641 +-155.15449,56.9151682,13.719616,-70165.9086454732,768203.772146199,187.021041870117,220,2.2718904720658,0.556738536446893 +-155.09356,56.9157299,13.719616,-66462.1058872634,768203.771883603,149.017211914062,121,2.17323643356388,0.198398909941905 +-155.03263,56.9162612,13.719616,-62758.4149401751,768203.778525556,85.2376098632812,22,1.93063126321789,-0.682812315164416 +-154.97169,56.916762,13.719616,-59054.2220461012,768203.771766074,78.855339050293,22,1.89683110339203,-0.805584143178041 +-154.91075,56.9172324,13.719616,-55350.1285078514,768203.772530693,60.5330085754395,22,1.78199225949393,-1.22271160248532 +-154.84981,56.9176723,13.719616,-51646.1282501962,768203.769434587,58.4479331970215,22,1.76676915849189,-1.27800625043036 +-154.78887,56.9180818,13.719616,-47942.2148914624,768203.773425117,51.9088859558105,22,1.71524170835418,-1.46516865672905 +-154.72793,56.9184608,13.719616,-44238.3823352188,768203.773146485,47.4461860656738,22,1.6762013076547,-1.60697453530931 +-154.66698,56.9188094,13.719616,-40534.0165154058,768203.773472033,34.7270622253418,22,1.5406680452374,-2.09927002945347 +-154.60604,56.9191275,13.719616,-36830.3267228593,768203.775839763,30.1314105987549,22,1.47901946359886,-2.32319527422168 +-154.54509,56.9194152,13.719616,-33126.0912072356,768203.779606746,27.2005767822266,22,1.43457811325046,-2.48461894351133 +-154.48414,56.9196723,13.719616,-29421.9116155379,768203.768419232,25.412389755249,22,1.40504550758153,-2.59188979674579 +-154.4232,56.9198991,13.719616,-25718.3891570334,768203.779504672,19.903413772583,22,1.29892757165815,-2.97734042909394 +-154.36225,56.9200953,13.20723357,-22014.3024163684,768203.770972406,16.1445808410645,22,1.20802677398769,-3.30751807190381 +-154.11845,56.9205758,13.69599637,-7198.26369452953,768203.773015057,43.8342819213867,22,1.64181389648101,-1.73187942783648 +-154.0575,56.9206198,13.719616,-3494.2999289576,768203.776700046,52.5074005126953,22,1.72022051817399,-1.44708419836968 +-153.99655,56.9206333,13.719616,209.657943572517,768203.776010579,74.8564224243164,22,1.87422906725469,-0.887681189692263 +-153.9356,56.9206163,9.770675502,3913.61617480789,768203.770940144,16.8005123138428,22,1.22532252527839,-3.24469496651706 +-153.6918,56.9202439,7.428345652,18729.5774103409,768203.774190761,17.3996887207031,30,1.24054147885213,-3.18941538321543 +-153.63085,56.9200746,12.42994226,22433.6310248032,768203.769950605,44.1853370666504,30,1.64527817234586,-1.71929618909258 +-153.5699,56.9198749,10.84828563,26137.7223942799,768203.772757928,97.2831726074219,30,1.98803772540963,-0.474295659048381 +-153.50895,56.9196447,13.719616,29841.8578217651,768203.771549095,117.433090209961,30,2.06979048933656,-0.177346285903814 +-153.448,56.9193841,13.719616,33546.0434655262,768203.777594371,143.651931762695,30,2.15731147055239,0.140554898847175 +-153.38706,56.919093,13.719616,37249.6779444807,768203.774250571,116.993911743164,130,2.06816326204407,-0.183256839887059 +-153.32611,56.9187714,13.719616,40953.9829175917,768203.772318016,78.8811416625977,30,1.89697318760986,-0.805068052744014 +-153.26517,56.9184194,13.719616,44657.7491033496,768203.771334919,105.743782043457,30,2.02425483936993,-0.342744763751102 +-153.20423,56.918037,13.719616,48361.5904252865,768203.777079327,166.940368652344,130,2.2225613682134,0.377561151326944 +-153.14329,56.917624,13.719616,52065.5133903543,768203.767417104,150.39094543457,130,2.17722168953902,0.212874497148918 +-153.08235,56.9171807,13.719616,55769.5238161124,768203.776023628,101.968795776367,130,2.00846729043377,-0.40008964770231 +-153.02141,56.9167068,13.719616,59473.6283835096,768203.769635553,103.688026428223,31,2.01572860830434,-0.373714468609933 +-152.96047,56.9162026,13.719616,63177.8328479326,768203.781956703,114.148536682129,130,2.05747034845919,-0.222096554088714 +-152.89954,56.9156678,13.719616,66881.5362468001,768203.769683012,102.981781005859,130,2.01276039840915,-0.384495854160737 +-152.8386,56.9151026,13.719616,70585.9598767527,768203.774972485,112.344421386719,130,2.05055151181419,-0.247227743615946 +-152.77767,56.914507,13.719616,74289.8945461195,768203.777397009,126.600746154785,130,2.1024362653176,-0.0587675095085211 +-152.71674,56.9138809,13.719616,77993.954390926,768203.776155739,134.863159179688,130,2.12989332884081,0.0409643822339574 +-152.65582,56.9132244,13.719616,81697.5377275471,768203.7704055,144.515716552734,130,2.15991508059402,0.150011953662678 +-152.59489,56.9125374,13.719616,85401.8664156354,768203.773350136,153.448181152344,130,2.18596174503124,0.244620873356843 +-152.53397,56.91182,13.719616,89105.7310458248,768203.771315723,164.613830566406,130,2.2164663210727,0.355422200412279 +-152.47305,56.9110722,13.719616,92809.7455363528,768203.776948464,163.441955566406,130,2.21336354994487,0.344152050056938 +-152.41213,56.9102939,13.719616,96513.9163674704,768203.779450769,138.720245361328,130,2.14213984829085,0.0854472363811459 +-152.35122,56.9094852,13.719616,100217.641801477,768203.775262695,78.0891571044922,31,1.89259073507319,-0.820986371233692 +-152.29031,56.908646,13.719616,103921.536041993,768203.767591384,78.589599609375,31,1.89536507617784,-0.810909172465799 +-152.2294,56.9077764,13.719616,107625.605033704,768203.767996111,81.3857040405273,31,1.91054812477155,-0.755760006299942 +-152.16849,56.9068764,13.719616,111329.854987392,768203.77689417,86.7605667114258,31,1.93832238011995,-0.654875983312814 +-152.10759,56.905946,13.719616,115033.684408929,768203.777395943,84.8581008911133,31,1.92869330810772,-0.689851521271994 +-152.04669,56.9049851,13.719616,118737.707539989,768203.774998966,86.8404693603516,31,1.93872216208846,-0.65342386109404 +-151.98579,56.9039938,13.719616,122441.930281371,768203.781319714,86.4800415039062,31,1.93691588937394,-0.659984759154725 +-151.9249,56.9029721,13.719616,126145.751136609,768203.777839015,84.0638809204102,31,1.92460943591225,-0.704685310739126 +-151.86401,56.9019199,13.719616,129849.784375646,768203.77177233,74.8054656982422,31,1.87393333096427,-0.888755388310597 +-151.80312,56.9008374,13.719616,133554.035497011,768203.785932381,72.8483123779297,31,1.86241949524888,-0.930576926004805 +-151.74224,56.8997244,13.719616,137257.903729647,768203.777863019,96.5774536132812,31,1.98487575049196,-0.485780854466877 +-151.68136,56.898581,13.719616,140962.002623122,768203.77880433,146.295349121094,134,2.16523051967862,0.169319145595302 +-151.62049,56.8974073,13.719616,144665.730276823,768203.77867358,199.360412597656,134,2.2996389237988,0.657528833337786 +-151.55962,56.8962031,13.719616,148369.701386611,768203.776396261,305.73193359375,231,2.48534080300232,1.33205106319834 +-151.49875,56.8949685,13.719616,152073.921764346,768203.783702482,626.970703125,330,2.79724724773915,2.46498429744521 +-134.74582,55.3441465,13.719616,1204009.92857099,768203.813374751,615,450,2.78887511577542,2.43457432450857 +-134.68987,55.3346259,13.719616,1207713.60570851,768203.720649085,341,351,2.5327543789925,1.5042707043766 +-134.63394,55.3250783,13.719616,1211417.78236971,768203.773376405,206,251,2.31386722036915,0.709210067641479 +-134.57804,55.3155037,13.719616,1215121.85499228,768203.788992305,193,151,2.28555730900777,0.60638038912377 +-134.52217,55.3059023,13.719616,1218825.82127291,768203.787560131,206,151,2.31386722036915,0.709210067641479 +-134.46633,55.2962739,13.719616,1222529.69174649,768203.746492645,203,151,2.30749603791321,0.686068114444982 +-134.41051,55.2866186,13.719616,1226234.07500494,768203.859844143,191,251,2.28103336724773,0.589948141389748 +-134.35473,55.2769365,13.719616,1229937.75648646,768203.76829377,200,251,2.30102999566398,0.662581603403571 +-134.29897,55.2672275,13.719616,1233641.95891588,768203.829788381,205,251,2.31175386105575,0.70153374340241 +-134.24324,55.2574916,13.719616,1237346.07867117,768203.858454448,305,251,2.48429983934679,1.32826998608084 +-134.18755,55.247729,13.719616,1241049.50557829,768203.687483984,422,351,2.62531245096167,1.84046804047259 +-134.13187,55.2379396,13.719616,1244754.07004981,768203.865624526,411,351,2.61384182187607,1.79880344159018 +-134.07623,55.2281234,13.719616,1248457.95301217,768203.831037488,179,151,2.25285303097989,0.487589116596209 +-134.02062,55.2182804,13.719616,1252161.76620308,768203.769387604,180,151,2.25527250510331,0.496377337199112 +-133.96504,55.2084107,13.719616,1255865.51034179,768203.690105927,136,151,2.13353890837022,0.0542061676367513 +-133.90948,55.1985143,13.719616,1259569.79712842,768203.781651886,129,151,2.11058971029925,-0.0291518701102782 +-133.85395,55.1885911,13.719616,1263274.02617558,768203.84365547,116.575958251953,151,2.06660899403281,-0.188902384936182 +-133.79846,55.1786414,13.719616,1266977.58378478,768203.716030919,115.218437194824,151,2.06152198022685,-0.207379871057755 +-133.74299,55.1686649,13.719616,1270681.699323,768203.746714516,154.502182006836,151,2.18893461726789,0.255419193862573 +-133.68755,55.1586618,13.719616,1274385.76238061,768203.765556986,167.245544433594,151,2.22335455661218,0.380442237989848 +-133.63214,55.1486321,13.719616,1278089.77689948,768203.771382642,157,151,2.19589965240923,0.280718189514898 +-133.57676,55.1385758,13.719616,1281793.746816,768203.763022969,126,151,2.10037054511756,-0.0662707948902998 +-133.52141,55.1284929,13.719616,1285497.676061,768203.739316604,88,151,1.94448267215017,-0.63250004433665 +-133.46609,55.1183834,13.719616,1289201.56855981,768203.699109287,73,151,1.86332286012046,-0.92729564694522 +-133.41079,55.1082475,13.719616,1292906.02914269,768203.857142796,90,50,1.95424250943932,-0.597049529567529 +-133.35553,55.0980849,13.719616,1296609.85647973,768203.791651219,102,151,2.00860017176192,-0.399606984790377 +-133.3003,55.0878959,13.719616,1300313.65196696,768203.727427047,59,50,1.77085201164214,-1.26317616242633 +-133.24509,55.0776804,11.70883898,1304018.03058227,768203.849087399,46.8097877502441,50,1.67033667190918,-1.62827656627073 +-157.03917,56.8495044,11.68651878,-184990.295245165,764499.781438266,23.6472320556641,20,1.37378031322171,-2.70545390663555 +-156.9784,56.8510077,13.7068294,-181286.289736478,764499.780546819,37.2304077148438,20,1.57089779225753,-1.98946695984749 +-156.91762,56.8524807,13.39865567,-177581.979354474,764499.771455241,111.051292419434,20,2.04552361725065,-0.265490491774701 +-156.85684,56.8539233,13.719616,-173877.966683049,764499.770166837,145.28955078125,20,2.16223438097918,0.158436314655831 +-156.79606,56.8553355,13.719616,-170174.245532496,764499.77599139,48.2467193603516,20,1.68346778789462,-1.58058060501795 +-156.73527,56.8567174,13.719616,-166470.200990533,764499.774336124,123.005577087402,20,2.08992480284894,-0.104212712321606 +-156.67448,56.8580689,13.719616,-162766.435606942,764499.7795731,65.4935607910156,20,1.81619860303912,-1.09846439926671 +-156.61368,56.8593901,13.719616,-159062.334487595,764499.778254727,44.6066436767578,20,1.64939954699189,-1.70432618002075 +-156.55288,56.8606809,13.719616,-155358.500159648,764499.783665642,61.84765625,20,1.79132324645539,-1.18881879451249 +-156.49207,56.8619414,13.719616,-151654.317747221,764499.783503479,128.387405395508,121,2.10852242221016,-0.0366608505126249 +-156.43126,56.8631714,13.719616,-147950.390163383,764499.778813758,147.18489074707,121,2.16786322982508,0.178881900297559 +-156.37044,56.8643711,13.719616,-144246.102121744,764499.769590267,168.623840332031,121,2.22691897593937,0.393389226372771 +-156.30962,56.8655404,13.719616,-140542.056104496,764499.766942905,192.49397277832,121,2.2844171357661,0.602238954472158 +-156.2488,56.8666794,13.719616,-136838.245534493,764499.781464456,180.148666381836,121,2.25563105144247,0.497679679842271 +-156.18797,56.8677879,13.719616,-133134.056715326,764499.770257182,195.906112670898,121,2.29204798708113,0.629956384510164 +-156.12714,56.8688661,13.719616,-129430.09096231,764499.776258522,194.527206420898,121,2.28898034999165,0.618813851010373 +-156.06631,56.8699138,13.719616,-125726.342798284,764499.776645279,211.193862915039,220,2.32468129387665,0.748489869264581 +-156.00547,56.8709312,13.719616,-122022.19705381,764499.774849097,230.180404663086,220,2.36206834922897,0.884290325632219 +-155.94463,56.8719182,13.719616,-118318.256144338,764499.778718232,273.771026611328,220,2.43738748452612,1.15787092325303 +-155.88379,56.8728748,13.719616,-114614.513865209,764499.787779754,296.710876464844,220,2.47233346644521,1.28480470415945 +-155.82294,56.873801,13.719616,-110910.355749036,764499.784874663,301.860748291016,220,2.47980664429541,1.3119494191687 +-155.76209,56.8746967,13.719616,-107206.384147562,764499.776219771,290.337829589844,220,2.46290362595139,1.25055283194146 +-155.70123,56.8755621,13.719616,-103501.983989547,764499.76811112,286.317443847656,220,2.45684780815432,1.22855637320002 +-155.64038,56.8763971,13.719616,-99798.3658974007,764499.780706735,280.321258544922,220,2.44765603432349,1.19516922705297 +-155.57952,56.8772017,13.719616,-96094.3071388749,764499.782993934,277.007843017578,220,2.44249206556638,1.17641221858373 +-155.51866,56.8779758,13.719616,-92390.4100219729,764499.779015659,268.514678955078,220,2.42896803236308,1.12728906984596 +-155.45779,56.8787196,13.719616,-88686.0595544854,764499.777359245,262.472137451172,220,2.41908320795741,1.09138456619479 +-155.39693,56.8794329,13.719616,-84982.4665500093,764499.782621015,250.120086669922,220,2.39814857049745,1.01534398759977 +-155.33606,56.8801158,13.719616,-81278.4080185772,764499.779464854,241.749450683594,220,2.38336549592834,0.961647641255198 +-155.27519,56.8807683,13.719616,-77574.4860105825,764499.780917462,227.120819091797,220,2.35625694576651,0.863181649516873 +-155.21431,56.8813904,13.719616,-73870.0860520205,764499.775542741,208.347198486328,220,2.31878766514795,0.727082527512822 +-155.15344,56.881982,13.719616,-70166.4186479417,764499.774688761,168.554260253906,121,2.22673973390464,0.392738168141833 +-155.09256,56.8825433,13.719616,-66462.2606635567,764499.778698398,111.244995117188,121,2.04628048129897,-0.262741345520694 +-155.03168,56.8830741,13.719616,-62758.2145245968,764499.776110053,81.8728713989258,22,1.91314002198649,-0.746345495814136 +-154.9708,56.8835745,13.719616,-59054.2738232259,764499.77782685,75.8723449707031,22,1.88008350692025,-0.866416193803489 +-154.90992,56.8840445,13.719616,-55350.4323449905,764499.78360878,63.5024147033691,22,1.80279023981812,-1.14716740161329 +-154.84903,56.884484,13.719616,-51646.0757557842,764499.774295143,49.7488975524902,22,1.69678346111843,-1.53221427919758 +-154.78815,56.8848931,13.719616,-47942.4142011016,764499.776944581,47.3035087585449,22,1.67489335591662,-1.61172538934862 +-154.72726,56.8852718,13.719616,-44238.2249415214,764499.776365086,50.7423934936523,22,1.7053709488252,-1.50102207273357 +-154.66637,56.8856201,13.719616,-40534.1100230676,764499.780151743,34.8350601196289,22,1.54201656439264,-2.09437182297595 +-154.60548,56.8859379,13.719616,-36830.0633312828,764499.776978484,31.1000003814697,22,1.49276039435385,-2.27328429166744 +-154.54459,56.8862253,13.719616,-33126.0785274918,764499.77785163,28.9084625244141,22,1.46102499464822,-2.3885563215832 +-154.4837,56.8864822,13.719616,-29422.1494762476,764499.771474121,34.4726257324219,22,1.53747436428035,-2.11087039025677 +-154.42281,56.8867088,13.719616,-25718.2697878167,764499.780040929,35.8055839538574,22,1.55395076103604,-2.05102341440825 +-154.36192,56.8869049,13.719616,-22014.4333973783,764499.781124992,25.6283111572266,22,1.40871998818724,-2.57854303438466 +-154.17924,56.8873106,13.71683724,-10902.5131507455,764499.781607163,59.9959983825684,22,1.7781222847449,-1.23676845537458 +-154.11834,56.8873849,13.719616,-7198.17920998552,764499.773756759,63.6817970275879,22,1.80401531019685,-1.14271759632784 +-154.05745,56.8874288,13.719616,-3494.4656190964,764499.770899853,64.2039794921875,22,1.80756194735134,-1.12983519787169 +-153.99655,56.8874423,9.585471212,209.850363584403,764499.771405315,54.3936882019043,22,1.73554850745333,-1.3914085662634 +-153.69208,56.8870533,11.34170641,18729.7353216977,764499.776653011,31.0447196960449,30,1.49198774293831,-2.27609078214537 +-153.63119,56.8868842,12.2529822,22433.538570442,764499.776841223,33.5981369018555,30,1.52631519537564,-2.15140367686257 +-153.57029,56.8866846,10.52433233,26137.9878480702,764499.77339815,30.0909385681152,30,1.47843573405435,-2.32531554654035 +-153.5094,56.8864547,13.719616,29841.872713856,764499.781424262,56.5189933776855,30,1.75219441831436,-1.33094586680018 +-153.44851,56.8861942,13.719616,33545.8078941634,764499.77093048,128.541915893555,130,2.1090447687018,-0.0347635389624629 +-153.38762,56.8859034,13.719616,37249.7993586002,764499.77551918,144.864593505859,130,2.16096225211016,0.153815579501823 +-153.32673,56.8855821,13.719616,40953.8535194313,764499.773011865,158.096954345703,130,2.19892350355906,0.291701679984099 +-153.26584,56.8852304,13.719616,44657.9765004308,764499.774721726,171.32926940918,130,2.23383156294818,0.418497715437524 +-153.20496,56.8848483,13.719616,48361.5662558417,764499.773535299,153.943756103516,130,2.1873620787879,0.249707285256086 +-153.14407,56.8844357,13.719616,52065.8456691977,764499.772484011,76.0297927856445,31,1.88098380684643,-0.86314604750042 +-153.08319,56.8839927,13.719616,55769.6043088262,764499.767802433,75.754638671875,31,1.87940923107426,-0.868865356133593 +-153.0223,56.8835193,13.719616,59474.0649137589,764499.775940653,69.5886993408203,31,1.8425387193175,-1.00278957872597 +-152.96142,56.8830155,13.719616,63178.0171749559,764499.779772658,74.3995666503906,31,1.87157040595055,-0.897338206406357 +-152.90054,56.8824812,13.719616,66882.0757534874,764499.776779897,76.3712768554688,31,1.882930051656,-0.856076730838469 +-152.83967,56.8819165,13.719616,70585.6384371217,764499.767748193,84.2742233276367,31,1.92569475874773,-0.700743108418684 +-152.77879,56.8813214,13.719616,74289.9279632361,764499.773647898,103.507835388184,31,2.01497322647943,-0.376458231005438 +-152.71792,56.8806959,13.719616,77993.7340210267,764499.772949413,123.944297790527,130,2.09322655131301,-0.0922198194872805 +-152.65705,56.88004,13.719616,81697.6710849634,764499.776581333,133.600875854492,130,2.1258093052767,0.0261300429527155 +-152.59618,56.8793536,13.719616,85401.7456029414,764499.773701299,144.858642578125,130,2.16094441125547,0.153750776425304 +-152.53531,56.8786368,13.719616,89105.9635710038,764499.775795746,160.868453979492,130,2.2064708880652,0.319115934748418 +-152.47445,56.8778896,13.719616,92809.7229381169,764499.769233291,170.227630615234,130,2.23103005427851,0.408321836319083 +-152.41359,56.877112,13.719616,96513.6381764876,764499.767231758,145.315124511719,130,2.16231081835956,0.158713957038775 +-152.35273,56.876304,13.719616,100217.715495777,764499.77016392,91.4437103271484,130,1.96115383923669,-0.571945607053563 +-152.29187,56.8754656,13.719616,103921.961104996,764499.778417144,84.4588241577148,31,1.9266450308496,-0.697291448910049 +-152.23102,56.8745968,13.719616,107625.772950546,764499.776187279,88.7693710327148,31,1.94826314273724,-0.618768296110669 +-152.17017,56.8736976,13.719616,111329.765501983,764499.778981326,91.9168701171875,31,1.96339522766917,-0.563804244510877 +-152.10932,56.8727679,13.719616,115033.945283864,764499.776075469,92.3185119628906,31,1.96528879568694,-0.556926264992193 +-152.04848,56.8718079,13.719616,118737.709615324,764499.772345825,91.8744354248047,31,1.96319468332877,-0.564532678796263 +-151.98764,56.8708175,13.719616,122441.673271097,764499.773861149,92.0730438232422,31,1.96413250063804,-0.56112625864926 +-151.9268,56.8697967,13.719616,126145.842455755,764499.781095994,81.8968505859375,31,1.91326720091246,-0.745883545654537 +-151.86597,56.8687455,13.719616,129849.615111118,764499.774987039,77.693977355957,31,1.89038735467673,-0.828989677741002 +-151.80514,56.8676639,13.719616,133553.605702009,764499.77447484,88.8283309936523,31,1.94855150217362,-0.61772089233177 +-151.74431,56.8665519,13.719616,137257.820430439,764499.780077553,124.877250671387,134,2.09648332862427,-0.0803902747159806 +-151.68349,56.8654095,13.719616,140961.657235609,764499.771102169,186.233535766602,134,2.27005788871283,0.550082070637545 +-151.62267,56.8642367,13.719616,144665.730579629,764499.768206017,306.19287109375,231,2.48599507506019,1.33442756606038 +-151.56185,56.8630336,13.719616,148370.046252145,764499.783102432,548.770629882812,330,2.73939085994878,2.25483338313344 +-134.65071,55.2932237,13.719616,1211417.72552361,764499.752662246,412,351,2.61489721603313,1.80263693440812 +-134.59485,55.2836568,13.719616,1215121.96403816,764499.827658345,217,251,2.33645973384853,0.791272525143927 +-134.53903,55.274063,13.719616,1218825.48739233,764499.68865601,205,251,2.31175386105575,0.70153374340241 +-134.48323,55.2644422,13.719616,1222529.51943996,764499.69022582,195,251,2.29003461136252,0.622643229225523 +-134.42745,55.2547946,13.719616,1226234.05783674,764499.854102416,200,251,2.30102999566398,0.662581603403571 +-134.37171,55.2451202,13.719616,1229937.89012523,764499.810296627,294,450,2.46834733041216,1.2703259203309 +-134.14903,55.2061542,13.719616,1244753.55159365,764499.706445678,437,450,2.64048143697042,1.89556612731603 +-134.09343,55.1963457,13.719616,1248457.56704088,764499.704483155,180,151,2.25527250510331,0.496377337199112 +-134.03786,55.1865105,13.719616,1252161.50564613,764499.68327387,176,151,2.24551266781415,0.460926822429992 +-133.98231,55.1766486,13.719616,1255865.97967279,764499.8307056,168,151,2.22530928172586,0.387542357536829 +-133.9268,55.16676,13.719616,1259569.77659302,764499.767916411,126,151,2.10037054511756,-0.0662707948902998 +-133.87132,55.1568447,13.719616,1263273.50865923,764499.682251049,110,151,2.04139268515822,-0.280495216219808 +-133.81586,55.1469028,13.719616,1266977.78478603,764499.773916867,125.673851013184,151,2.09924492333385,-0.0703593744931923 +-133.76043,55.1369342,13.719616,1270682.00400564,764499.841433007,139.866180419922,151,2.1457127149736,0.0984249079705944 +-133.70504,55.126939,13.719616,1274385.55868019,764499.702343711,156.79508972168,151,2.19533245796468,0.278657977398872 +-133.64967,55.1169172,13.719616,1278089.66927554,764499.738696182,166,151,2.22010808804005,0.368650137501496 +-133.59433,55.1068688,13.719616,1281793.73146629,764499.757979392,161,151,2.20682587603185,0.320405352366949 +-133.53902,55.0967938,13.719616,1285497.74918345,764499.759025333,102,151,2.00860017176192,-0.399606984790377 +-133.48374,55.0866923,13.719616,1289201.7229674,764499.751279833,117,151,2.06818586174616,-0.183174751318448 +-133.42849,55.0765643,13.719616,1292905.65671178,764499.733580138,80,50,1.90308998699194,-0.782850091479914 +-133.37327,55.0664098,13.719616,1296609.55430472,764499.704770558,174,151,2.2405492482826,0.442898265990424 +-133.31807,55.0562287,13.719616,1300314.03130213,764499.848902398,155,151,2.19033169817029,0.260493790466696 +-133.26291,55.0460212,13.715611,1304017.86824323,764499.794994604,78,50,1.89209460269048,-0.822788465657962 +-133.20778,55.0357873,9.626248904,1307721.67723527,764499.737143467,21.9859790802002,50,1.34214581039968,-2.82035945027122 +-157.40056,56.8066972,12.51096141,-207213.910500295,760795.764511386,15.574686050415,20,1.19241930104892,-3.36420886843369 +-157.33988,56.808381,13.62931782,-203510.061772283,760795.769443895,18.443717956543,20,1.26584847231696,-3.09749315961607 +-157.0971,56.8148133,12.33358511,-188694.350659362,760795.784079824,11.0026321411133,20,1.04149659312335,-3.91240322124897 +-157.03639,56.8163456,13.66241787,-184990.313355367,760795.782079954,32.5068397521973,20,1.51197475033603,-2.20349226641697 +-156.97567,56.8178476,13.37213178,-181285.97635426,760795.768537135,38.3680953979492,20,1.58397024124443,-1.94198409387868 +-156.91495,56.8193192,13.719616,-177581.942811711,760795.760000341,163.514053344727,20,2.21355508438336,0.34484775780692 +-156.85423,56.8207606,13.719616,-173878.205583454,760795.778063022,108.094650268555,121,2.03380420074019,-0.308058757595203 +-156.7935,56.8221716,13.7037951,-170174.15066287,760795.774117149,45.2112083435059,121,1.65524611441992,-1.68308977834567 +-156.73277,56.8235523,13.68724072,-166470.380222816,760795.785377383,47.7374458312988,121,1.67885917857841,-1.59732038948249 +-156.67203,56.8249026,13.719616,-162766.279734164,760795.775526453,56.4598007202148,20,1.7517393409334,-1.33259883773983 +-156.61129,56.8262226,13.719616,-159062.451387897,760795.780693317,123.242141723633,121,2.09075923695644,-0.101181809471982 +-156.55054,56.8275123,13.719616,-155358.280203839,760795.776854638,116.695037841797,121,2.06705238917524,-0.187291847221312 +-156.48979,56.8287716,13.719616,-151654.369258311,760795.776752973,136.359909057617,121,2.13468670291335,0.0583752850305867 +-156.42903,56.8300006,13.719616,-147950.103130379,760795.768659421,148.867477416992,121,2.17279982924258,0.196813038427675 +-156.36827,56.8311993,13.719616,-144246.084476054,760795.775380791,186.025299072266,121,2.26957201142397,0.548317225641221 +-156.30751,56.8323675,13.719616,-140542.307905996,760795.774040757,193.607345581055,121,2.28692183068312,0.611336721321878 +-156.24674,56.8335055,13.719616,-136838.157241398,760795.776931894,188.83740234375,121,2.27608801762485,0.571985220016129 +-156.18597,56.834613,13.719616,-133134.236267699,760795.771773815,195.115631103516,121,2.29029206298793,0.623578367013042 +-156.12519,56.8356903,13.719616,-129429.928865452,760795.772005697,191.97770690918,121,2.28325079990956,0.598002489735826 +-156.06442,56.8367371,13.719616,-125726.447576712,760795.783189964,215.921173095703,220,2.33429523106868,0.783410433236925 +-156.00363,56.8377536,13.719616,-122021.9590388,760795.7703377,247.41145324707,220,2.39341980025216,0.998167744343468 +-155.94285,56.8387397,13.719616,-118318.283867038,760795.778603856,283.579437255859,220,2.45267473634855,1.21339858528817 +-155.88206,56.8396954,13.719616,-114614.19822059,760795.771326637,309.182800292969,220,2.49021532630185,1.34975672314972 +-155.82127,56.8406208,13.719616,-110910.304410821,760795.777577056,292.191558837891,220,2.46566766538651,1.26059261210522 +-155.76047,56.8415158,13.719616,-107205.987741394,760795.769615215,289.407684326172,220,2.46151005828318,1.24549099640671 +-155.69968,56.8423804,13.719616,-103502.4596478,760795.77985602,283.59130859375,220,2.45269291661112,1.21346462119097 +-155.63888,56.8432147,13.719616,-99798.4960108212,760795.787313152,277.800109863281,220,2.44373241315468,1.18091751505489 +-155.57807,56.8440185,13.719616,-96094.091186115,760795.770949589,271.489776611328,220,2.43375348016839,1.14467118217764 +-155.51727,56.844792,13.719616,-92390.4560665988,760795.782188702,263.947509765625,220,2.42151756896949,1.10022686022645 +-155.45646,56.8455351,13.719616,-88686.367081732,760795.781123071,255.124420166016,220,2.40675203068254,1.04659421066403 +-155.39565,56.8462478,13.719616,-84982.4268439825,760795.781866448,242.882125854492,220,2.38539555544577,0.969021396859175 +-155.33483,56.8469301,13.719616,-81278.0203259002,760795.771838841,230.601745605469,220,2.36286259048667,0.887175236579203 +-155.27402,56.847582,13.719616,-77574.3589584398,760795.775748519,214.997131347656,220,2.33243266527284,0.77664506263721 +-155.2132,56.8482036,13.719616,-73870.2186895293,760795.78052077,189.920257568359,121,2.27857129059768,0.581005176250119 +-155.15238,56.8487947,13.719616,-70166.2025472945,760795.775782493,148.118041992188,121,2.17060796237275,0.188851552335357 +-155.09156,56.8493554,13.719616,-66462.3041077428,760795.772407452,88.2577362060547,22,1.94575278368417,-0.627886636719234 +-155.03073,56.8498858,13.719616,-62757.9081676212,760795.771834757,78.8808670043945,22,1.8969716754265,-0.805073545425591 +-154.96991,56.8503857,13.719616,-59054.2265119848,760795.770952797,74.6083755493164,22,1.8727875841841,-0.892917067644862 +-154.90908,56.8508553,13.719616,-55350.0349540802,760795.77349539,57.7158050537109,22,1.76129475782977,-1.29789083618468 +-154.84825,56.8512945,13.719616,-51645.9362750829,760795.777529844,43.9062232971191,22,1.64252608179211,-1.72929256750862 +-154.78742,56.8517032,13.719616,-47941.9243952435,760795.771687465,45.4406433105469,22,1.6574444711238,-1.67510471932368 +-154.72659,56.8520816,13.719616,-44237.992827333,760795.778088787,59.9206581115723,22,1.77757657459553,-1.23875063039828 +-154.66576,56.8524295,13.719616,-40534.1356130203,760795.774235898,47.229564666748,22,1.67421394253413,-1.61419321267769 +-154.60493,56.8527471,13.719616,-36830.3463053319,760795.782278917,37.7593841552734,22,1.57702490246534,-1.96721154672136 +-154.54409,56.8530342,13.719616,-33126.0100848232,760795.774760562,32.2430725097656,22,1.50843641993383,-2.21634449237779 +-154.48326,56.8532909,13.719616,-29422.3382654022,760795.773235587,75.8795547485352,22,1.88012477383996,-0.866266300572361 +-154.42242,56.8535173,13.719616,-25718.1069230037,760795.779321423,67.3960571289062,22,1.82863448975124,-1.05329370917286 +-154.36158,56.8537132,13.719616,-22013.9188155034,760795.775580083,56.7000007629395,22,1.75358306473665,-1.32590190663525 +-154.23991,56.8540138,12.41036291,-14606.2560245411,760795.77393049,38.6630821228027,22,1.58729647192666,-1.92990227464004 +-154.17907,56.8541185,13.719616,-10902.1600927153,760795.773121095,56.6137619018555,22,1.75292201407794,-1.32830303131034 +-154.11823,56.8541928,13.719616,-7198.08245723666,760795.773355149,58.5348930358887,22,1.7674148290803,-1.27566099056054 +-154.05739,56.8542367,9.146968532,-3494.01690351636,760795.774597046,43.0933723449707,22,1.63441048186983,-1.75877074284918 +-153.69236,56.8538615,9.837192446,18729.8620052689,760795.777916746,29.4490795135498,30,1.4690717246432,-2.35932830147601 +-153.63152,56.8536925,13.719616,22434.0170783256,760795.774723921,45.7251358032227,30,1.66015500400089,-1.66525929025099 +-153.57069,56.8534932,13.719616,26137.6009145913,760795.780001811,63.9252281188965,30,1.80567228649268,-1.13669898547325 +-153.50985,56.8532634,13.719616,29841.837501565,760795.778842046,54.7588043212891,30,1.73845395658512,-1.38085514571901 +-153.44902,56.8530032,13.719616,33545.5153519542,760795.774084382,119.683952331543,130,2.0780359224943,-0.147396519193972 +-153.38818,56.8527126,13.719616,37249.8583188204,760795.775398213,172.718200683594,130,2.23733810502524,0.431234477128169 +-153.32735,56.8523916,13.719616,40953.6549763617,760795.772262597,172.851181030273,130,2.23767235126737,0.432448554882936 +-153.26652,56.8520402,13.719616,44657.5203575036,760795.769882592,171.919174194336,130,2.23532431637529,0.423919821959025 +-153.20568,56.8516584,13.719616,48362.0694948969,760795.775708759,105.726928710938,130,2.0241856164567,-0.342996201130133 +-153.14485,56.8512462,13.719616,52066.0909619068,760795.775917387,77.8596954345703,31,1.89131270054649,-0.825628557422037 +-153.08403,56.8508036,13.719616,55769.5909708893,760795.76903277,72.8483505249023,31,1.86241972266685,-0.930576099957823 +-153.0232,56.8503306,13.719616,59473.7933731842,760795.771504569,71.0062561035156,31,1.85129661451541,-0.970978403615007 +-152.96238,56.8498272,13.719616,63177.4867410972,760795.766206337,67.8977813720703,31,1.8318555835057,-1.04159377726498 +-152.90155,56.8492935,13.719616,66881.8947406215,760795.783005242,67.9029083251953,31,1.83188837579058,-1.04147466632641 +-152.84073,56.8487293,13.719616,70585.806302143,760795.78025788,71.8543701171875,31,1.85645318666737,-0.952248261726828 +-152.77991,56.8481347,13.719616,74289.8362813392,760795.778905307,77.1442642211914,31,1.88730364122627,-0.840190605172515 +-152.71909,56.8475097,13.719616,77993.9908880848,760795.779232339,94.5751342773438,31,1.97577696657454,-0.518830234706417 +-152.65828,56.8468543,13.719616,81697.667512096,760795.769236519,112.402984619141,130,2.05077784314064,-0.246405643636884 +-152.59746,56.8461686,13.719616,85402.0897658925,760795.78443418,139.662048339844,130,2.14507840728947,0.0961209214123915 +-152.53665,56.8454524,13.719616,89106.0466795379,760795.777679152,154.933242797852,130,2.19014461088203,0.259814236035699 +-152.47585,56.8447059,13.719616,92809.5439792416,760795.769953946,169.745559692383,130,2.22979842256186,0.403848198381527 +-152.41504,56.843929,13.719616,96513.8057470969,760795.777851935,159.418579101562,130,2.20253893394271,0.304833955084084 +-152.35424,56.8431217,13.719616,100217.620550281,760795.773237318,115.262191772461,130,2.0616868736666,-0.206780931019282 +-152.29344,56.842284,13.719616,103921.603414301,760795.770471697,93.9524841308594,31,1.97290826746009,-0.529250168698357 +-152.23264,56.8414159,13.719616,107625.760544326,760795.769956163,97.3992080688477,31,1.98855542574178,-0.472415223675636 +-152.17185,56.8405175,13.719616,111329.489018024,760795.766497267,97.7296600341797,31,1.99002638802092,-0.467072268823374 +-152.11105,56.8395887,13.719616,115034.012965184,760795.782339587,97.8666763305664,31,1.99063483940902,-0.464862199712456 +-152.05027,56.8386295,13.719616,118737.512129816,760795.765963321,94.6924209594727,31,1.97631522010992,-0.516875144233062 +-151.98948,56.83764,13.719616,122441.818835357,760795.780945758,83.9848327636719,31,1.92420086175473,-0.706169368697922 +-151.9287,56.83662,13.719616,126145.722309233,760795.769136559,74.768684387207,31,1.87371973896682,-0.889531215410556 +-151.86792,56.8355698,13.719616,129849.836527769,760795.782363307,83.6937561035156,31,1.92269305905732,-0.711646138464627 +-151.80715,56.8344891,13.719616,133553.559914989,760795.767558189,109.260025024414,134,2.03846129564739,-0.291142859625037 +-151.74638,56.8333781,13.719616,137257.50676285,760795.766538788,164.279220581055,134,2.21558263368642,0.352212395595834 +-151.68561,56.8322367,13.719616,140961.68362751,760795.768683575,272.860107421875,231,2.43594004577262,1.15261341256015 +-151.62485,56.831065,13.719616,144665.487487357,760795.763906902,472.848846435547,330,2.67472233386657,2.01993883816782 +-134.61164,55.251806,13.719616,1215121.57190575,760795.712673332,477,351,2.67851837904011,2.0337271577373 +-134.55585,55.2422198,13.719616,1218825.86520344,760795.80316696,228,351,2.35793484700045,0.869276265719263 +-134.50009,55.2326067,13.719616,1222530.05194955,760795.85915908,202,251,2.30535136944662,0.678278066425006 +-134.44437,55.2229667,13.719616,1226233.52742296,760795.694740223,268,351,2.42813479402879,1.12426251038591 +-134.22174,55.1841387,13.719616,1241049.49798872,760795.68398987,344,351,2.53655844257153,1.51808814908349 +-134.16615,55.1743648,13.719616,1244753.72037572,760795.75790029,203,251,2.30749603791321,0.686068114444982 +-134.11059,55.1645641,13.719616,1248457.8613942,760795.800323418,187,151,2.2718416065365,0.556561042896859 +-134.05506,55.1547367,13.719616,1252161.92178367,760795.820673321,179,151,2.25285303097989,0.487589116596209 +-133.99956,55.1448825,13.719616,1255865.90884856,760795.807092661,163,151,2.21218760440396,0.339880680204086 +-133.94409,55.1350017,13.719616,1259569.819988,760795.779635125,139,151,2.14301480025409,0.0886253116478125 +-133.88865,55.1250943,13.719616,1263273.65916605,760795.737082893,116,151,2.06445798922692,-0.19671544834909 +-133.83323,55.1151602,13.719616,1266978.04249036,760795.858378725,124,151,2.09342168516224,-0.0915110376501457 +-133.77785,55.1051994,13.719616,1270681.7563012,760795.761329522,108.338218688965,151,2.03478169058372,-0.304508235480124 +-133.72249,55.0952121,13.719616,1274386.01551798,760795.848099932,119.171691894531,151,2.07617310511856,-0.154162803603674 +-133.66717,55.0851982,13.719616,1278089.60977292,760795.723646704,123,151,2.0899051114394,-0.10428423714156 +-133.61187,55.0751577,13.719616,1281793.76064201,760795.771133062,145,151,2.16136800223497,0.155289379767752 +-133.5566,55.0650906,13.719616,1285497.86323675,760795.797490764,123,151,2.0899051114394,-0.10428423714156 +-133.50136,55.054997,13.719616,1289201.91810066,760795.812159401,106,151,2.02530586526477,-0.338927137708368 +-133.44615,55.0448769,13.719616,1292905.92912755,760795.81396962,90,151,1.95424250943932,-0.597049529567529 +-133.39097,55.0347304,13.719616,1296609.89680608,760795.812360256,127,151,2.10380372095596,-0.0538005203193092 +-133.33582,55.0245573,13.719616,1300313.83180961,760795.784970692,173,151,2.2380461031288,0.433806128323048 +-133.2807,55.0143578,13.719616,1304017.7312074,760795.751851888,90,151,1.95424250943932,-0.597049529567529 +-133.22561,55.0041319,13.719616,1307721.598845,760795.711853458,98,50,1.99122607569249,-0.462714660775254 +-133.17054,54.9938796,9.922584943,1311426.04738214,760795.861302899,34.9672622680664,50,1.54366163092475,-2.08839647178256 +-157.33683,56.7752279,13.6546995,-203510.166206219,757091.773029048,23.1471385955811,20,1.36449731202974,-2.73917241659715 +-157.2762,56.77688,13.49101794,-199806.336382282,757091.783710046,24.6045970916748,20,1.39101625771413,-2.64284803661073 +-157.09427,56.7816546,13.719616,-188694.383914424,757091.788278424,36.6729316711426,20,1.56434562928724,-2.0132662859291 +-157.03361,56.7831855,13.68091259,-184990.022168141,757091.765120144,99.9606552124023,20,1.99982909413507,-0.431466042245899 +-156.97295,56.7846862,13.57248494,-181285.968602366,757091.766470616,144.561019897461,20,2.16005120356973,0.150506391163835 +-156.91229,56.7861566,13.719616,-177582.217586274,757091.780468994,72.651481628418,121,1.8612444755712,-0.93484493285812 +-156.79095,56.7890064,13.719616,-170174.380308984,757091.781224982,131.175033569336,121,2.11785118401179,-0.00277612495536663 +-156.73027,56.7903859,13.719616,-166470.281261799,757091.780003717,156.948547363281,121,2.19575730044364,0.280201126544561 +-156.66959,56.7917351,13.719616,-162766.460150326,757091.79094578,46.5168838500977,121,1.66761061379425,-1.63817838743862 +-156.6089,56.7930539,13.719616,-159062.301879062,757091.778307281,72.0247116088867,121,1.85748152801569,-0.948513032431889 +-156.54821,56.7943425,13.719616,-155358.408781335,757091.788825269,128.810165405273,121,2.10995013790896,-0.031474979583933 +-156.48751,56.7956007,13.719616,-151654.166187533,757091.776750025,128.428833007812,121,2.1086625362753,-0.0361519162354989 +-156.42681,56.7968286,13.719616,-147950.176877303,757091.77658259,153.168823242188,121,2.18517037579412,0.241746394408375 +-156.36611,56.7980262,13.719616,-144246.434690106,757091.787737545,188.694381713867,121,2.27575896944427,0.570790023104559 +-156.3054,56.7991934,13.719616,-140542.324474292,757091.777329698,190.208618164062,121,2.27923019049994,0.583398488763904 +-156.24469,56.8003304,13.719616,-136838.448660025,757091.789383339,191.924301147461,121,2.28312996788848,0.597563593346355 +-156.18397,56.801437,13.719616,-133134.192470833,757091.781005555,183.758239746094,121,2.26424682202034,0.528974617766851 +-156.12325,56.8025132,13.719616,-129430.159089181,757091.772829969,210.273620605469,121,2.32278479268599,0.74160123562476 +-156.06253,56.8035591,13.719616,-125726.341972749,757091.775495248,238.119338989258,220,2.37679466829549,0.93778051979176 +-156.0018,56.8045747,13.719616,-122022.12557803,757091.770128677,264.921813964844,220,2.42311772007342,1.10603906576454 +-155.94107,56.80556,13.719616,-118318.113115479,757091.775734996,295.044586181641,220,2.46988765011208,1.27592080113202 +-155.88034,56.8065149,13.719616,-114614.29873323,757091.780690099,305.167541503906,220,2.48453833893097,1.32913628464515 +-155.8196,56.8074394,13.719616,-110910.066854731,757091.76783686,291.032440185547,220,2.46394140069844,1.25432232603314 +-155.75886,56.8083336,13.719616,-107206.020361954,757091.765703864,285.801330566406,220,2.45606424634544,1.22571025305936 +-155.69812,56.8091975,13.719616,-103502.153084838,757091.77386436,279.455078125,220,2.44631200581676,1.1902873318926 +-155.63738,56.810031,13.719616,-99798.4591276873,757091.780750921,272.854583740234,220,2.43593125398271,1.15258147826979 +-155.57663,56.8108342,13.719616,-96094.3226461271,757091.782650695,265.581787109375,220,2.42419828895988,1.10996400038524 +-155.51588,56.811607,13.719616,-92390.347100093,757091.783609761,259.042419433594,220,2.41337088770081,1.07063578856427 +-155.45512,56.8123494,13.719616,-88685.916908777,757091.76990435,245.414642333984,220,2.38990047075914,0.985384535108185 +-155.39437,56.8130615,13.719616,-84982.2443886868,757091.779601404,237.810562133789,220,2.37623113949443,0.935733622339167 +-155.33361,56.8137432,13.719616,-81278.1048350771,757091.775054145,224.446701049805,220,2.35111322646124,0.84449819283649 +-155.27285,56.8143945,13.719616,-77574.1014201528,757091.769290566,201.750274658203,121,2.30481413463307,0.6763266762401 +-155.21209,56.8150155,13.719616,-73870.2277345224,757091.773155778,165.050765991211,121,2.21761754420698,0.359603771427783 +-155.15133,56.8156061,13.719616,-70166.4777959888,757091.775196363,117.809852600098,121,2.07118161261512,-0.172293329089968 +-155.09056,56.8161664,13.719616,-66462.235837156,757091.776279086,79.5095825195312,22,1.9004194731164,-0.792550160116442 +-155.02979,56.8166963,13.719616,-62758.1052318366,757091.776102341,74.1370468139648,22,1.87003528228778,-0.90291421371747 +-154.96902,56.8171958,13.719616,-59054.0797723559,757091.774412549,66.4482040405273,22,1.82248324734302,-1.07563677733888 +-154.90825,56.8176649,13.719616,-55350.1532506076,757091.770970669,51.222785949707,22,1.70946319556312,-1.48615786453793 +-154.84748,56.8181037,13.719616,-51646.3193156961,757091.776709927,41.6664657592773,22,1.61978666421205,-1.81188862263537 +-154.7867,56.8185121,13.719616,-47941.9625441639,757091.7730439,42.9467811584473,22,1.63293061921476,-1.76414602640728 +-154.72593,56.8188901,13.719616,-44238.2954815884,757091.774772853,36.6578063964844,22,1.56416647321742,-2.01391703191091 +-154.66515,56.8192378,13.719616,-40534.0930518652,757091.778993709,43.1641006469727,22,1.63512269652423,-1.75618377593812 +-154.60437,56.819555,13.719616,-36829.9586562819,757091.770443038,42.3771286010742,22,1.62713152634938,-1.78520998692022 +-154.5436,56.8198419,13.719616,-33126.4952488156,757091.776273273,51.5435180664062,22,1.71217405768955,-1.47631123953766 +-154.48282,56.8200984,13.719616,-29422.477976066,757091.774655183,68.2990417480469,22,1.83441461046843,-1.03229866091731 +-154.42204,56.8203246,13.719616,-25718.50993393,757091.782170204,66.7992172241211,22,1.82477137329536,-1.06732565078383 +-154.36125,56.8205203,13.719616,-22013.9756862628,757091.77307847,58.4914169311523,22,1.76709214210066,-1.27683308177459 +-154.30047,56.8206857,13.719616,-18310.0876452903,757091.776790616,30.4567184448242,22,1.48368310851811,-2.30625558473818 +-154.23969,56.8208207,13.719616,-14606.2302934224,757091.778196465,28.0750770568848,22,1.44832095693114,-2.43470101266499 +-154.17891,56.8209253,13.719616,-10902.3974194282,757091.7772314,38.4249153137207,22,1.58461291901305,-1.93964970478455 +-154.11812,56.8209995,12.82014819,-7197.9734345808,757091.772761458,57.8316421508789,22,1.7621655244312,-1.29472796334676 +-153.81421,56.820915,13.36625315,11321.6522260206,757091.779068673,18.8367233276367,30,1.27500535894045,-3.06423273376391 +-153.75343,56.8208069,13.23617654,15025.4875819576,757091.77319373,36.5359191894531,30,1.56272003802271,-2.01917089739183 +-153.69264,56.8206685,13.719616,18729.9574566345,757091.778933309,57.856517791748,30,1.76235229123146,-1.29404957301969 +-153.63186,56.8204997,13.719616,22433.8493376901,757091.780112244,51.1047973632812,30,1.70846167059669,-1.48979568907969 +-153.57108,56.8203005,13.719616,26137.7788136107,757091.77907389,57.7416076660156,30,1.76148887152183,-1.29718575984957 +-153.5103,56.8200709,13.719616,29841.7520953358,757091.775913581,104.072944641113,30,2.01733784266872,-0.367869270077315 +-153.44952,56.8198109,13.719616,33545.7753936319,757091.770741233,91.8489151000977,30,1.96307403087782,-0.564970922935718 +-153.38874,56.8195206,13.719616,37249.8548163552,757091.774839435,138.152160644531,130,2.14035768149762,0.0789738979071035 +-153.32796,56.8191999,13.719616,40953.9966561231,757091.777188811,180.007858276367,130,2.25529146472313,0.496446203949943 +-153.26719,56.8188488,13.719616,44657.5977456225,757091.77121841,163.504486083984,130,2.21352967292775,0.344755456147009 +-153.20641,56.8184674,13.719616,48361.8829161202,757091.781145271,123.575370788574,130,2.09193192223773,-0.0969222818126151 +-153.14564,56.8180555,13.719616,52065.6398787989,757091.770829532,75.9412536621094,31,1.88047776233291,-0.864984145613011 +-153.08486,56.8176133,13.719616,55770.0933207452,757091.777905949,78.9342575073242,31,1.89726552814518,-0.804006188477442 +-153.02409,56.8171407,13.719616,59474.030829336,757091.775190721,71.574089050293,31,1.8547558293035,-0.958413548146429 +-152.96332,56.8166378,13.719616,63178.0678162479,757091.781907187,67.1838073730469,31,1.82726461210241,-1.05826949579541 +-152.90256,56.8161045,13.719616,66881.6012659021,757091.777067555,64,31,1.80617997398389,-1.13485491959676 +-152.84179,56.8155408,13.719616,70585.8561407222,757091.78051108,65.9605102539062,31,1.81928400657828,-1.08725733295063 +-152.78103,56.8149467,13.719616,74289.6198930965,757091.771807974,65.6866607666016,31,1.81747718472513,-1.0938202256396 +-152.72027,56.8143223,13.719616,77993.5078921142,757091.772469879,69.1340484619141,31,1.8396919897363,-1.01312971310238 +-152.65951,56.8136675,13.719616,81697.5265385773,757091.771638645,81.8336791992188,31,1.91293207726676,-0.747100810389552 +-152.59875,56.8129823,13.719616,85401.6820381716,757091.769627544,123.286338806152,130,2.09091495567274,-0.100616194647824 +-152.53799,56.8122668,13.719616,89105.9803503915,757091.777920221,152.145629882812,130,2.18225948252372,0.231173199198609 +-152.47724,56.8115209,13.719616,92809.8185276181,757091.771727595,168.527435302734,130,2.22667061162093,0.392487096277955 +-152.41649,56.8107447,13.719616,96513.8118851639,757091.77542141,165.609069824219,130,2.21908411787607,0.364930785595728 +-152.35574,56.8099381,13.719616,100217.966871998,757091.778217084,131.134323120117,130,2.11771637888081,-0.0032657756683179 +-152.295,56.8091012,13.719616,103921.680026952,757091.776006961,101.802253723145,130,2.00775739262442,-0.402668199170866 +-152.23426,56.8082339,13.719616,107625.56719548,757091.772568736,104.65950012207,130,2.01977865611791,-0.359003538952312 +-152.17352,56.8073362,13.719616,111329.634578892,757091.768317162,102.426193237305,130,2.01041103206729,-0.393029423290263 +-152.11278,56.8064082,13.719616,115033.888060726,757091.774835459,100.106605529785,130,2.00046273532634,-0.42916447658 +-152.05205,56.8054499,13.719616,118737.724432814,757091.774687257,88.8239059448242,31,1.94852986693477,-0.617799477694561 +-151.99132,56.8044612,13.719616,122441.759578481,757091.773940193,72.231819152832,31,1.85872855267128,-0.943983482946514 +-151.93059,56.8034422,13.719616,126145.999348344,757091.78421997,69.9795608520508,31,1.84497121279494,-0.993954068113145 +-151.86987,56.8023928,13.719616,129849.840889703,757091.775307587,87.8355560302734,31,1.94367035487978,-0.635450612521123 +-151.80915,56.8013131,13.719616,133553.89940851,757091.77729398,129.330581665039,134,2.11170123081989,-0.0251145103197769 +-151.74844,56.8002031,13.719616,137257.571692507,757091.770026222,195.426818847656,134,2.29098416264949,0.62609227052874 +-151.68772,56.7990627,13.719616,140962.083049166,757091.783660194,370.244384765625,231,2.56848848060636,1.63406716096618 +-151.62702,56.797892,13.719616,144665.61114158,757091.766215145,616.211364746094,330,2.78972970371965,2.4376784318457 +-134.51693,55.2007672,13.719616,1222530.08310119,757091.865181075,326,351,2.51321760006794,1.43330754697073 +-134.23879,55.1523376,13.719616,1241049.62174436,757091.722906089,508,450,2.70586371228392,2.13305321321398 +-134.18324,55.1425714,13.719616,1244753.97313147,757091.833944356,184,151,2.26481782300954,0.531048656339518 +-134.12773,55.1327784,13.719616,1248457.63000176,757091.722690457,173,151,2.2380461031288,0.433806128323048 +-134.07224,55.1229588,13.719616,1252161.80856131,757091.784610248,174,151,2.2405492482826,0.442898265990424 +-134.01678,55.1131124,13.719616,1255865.91000776,757091.809765117,169,151,2.22788670461367,0.396904293135091 +-133.96135,55.1032394,13.719616,1259569.9317461,757091.818202881,148,151,2.17026171539496,0.187593884483276 +-133.90595,55.0933397,13.719616,1263273.88105813,757091.798071022,120,151,2.07918124604762,-0.143236377140402 +-133.85058,55.0834135,13.719616,1266977.75527612,757091.769411558,124,151,2.09342168516224,-0.0915110376501457 +-133.79524,55.0734606,13.719616,1270681.56499737,757091.70976129,116,151,2.06445798922692,-0.19671544834909 +-133.73992,55.0634811,13.719616,1274385.92022942,757091.82043925,109.587005615234,151,2.03975906031467,-0.286429007934553 +-133.68464,55.053475,13.719616,1278089.60615975,757091.717020455,121,151,2.08278537031645,-0.130145169076543 +-133.62938,55.0434424,13.719616,1281793.84211834,757091.793274951,123,151,2.0899051114394,-0.10428423714156 +-133.57415,55.0333832,13.719616,1285498.02600313,757091.845508581,100,151,2,-0.430845263363071 +-133.51896,55.0232976,13.719616,1289201.54560421,757091.699637639,78,151,1.89209460269048,-0.822788465657962 +-133.46379,55.0131854,13.69918773,1292905.63031992,757091.720959614,105,151,2.02118929906994,-0.35387968111297 +-133.40865,55.0030468,13.719616,1296609.66789429,757091.73595079,81,151,1.90848501887865,-0.763253795771988 +-133.35354,54.9928817,13.719616,1300313.6655895,757091.732841703,185,151,2.26717172840301,0.539598712600118 +-133.29846,54.9826902,13.719616,1304017.62386892,757091.721072972,145,151,2.16136800223497,0.155289379767752 +-133.24341,54.9724723,13.719616,1307721.54657834,757091.699487602,98,151,1.99122607569249,-0.462714660775254 +-133.18838,54.9622279,13.43944992,1311426.05036707,757091.853816876,105.373062133789,50,2.02272960080157,-0.348284865577801 +-157.51548,56.7369402,12.47187184,-214621.982061983,753387.766367579,24.4989891052246,20,1.38914816456534,-2.64963348413404 +-157.45492,56.7386815,13.70451109,-210918.023205116,753387.762581275,27.6630477905273,20,1.44190002702742,-2.45802366279118 +-157.39436,56.7403927,13.67348317,-207214.414381097,753387.791858049,24.5320014953613,20,1.38973298248811,-2.64750925851487 +-157.33378,56.7420735,13.58216053,-203509.931321918,753387.758668873,30.9434032440186,20,1.49056807693985,-2.28124741426479 +-157.27321,56.7437242,13.719616,-199806.396013688,753387.789250853,37.2514610290527,20,1.57114331075981,-1.98857516656928 +-157.21262,56.7453445,13.71958849,-196101.97418956,753387.759129478,38.2170867919922,20,1.58225757862735,-1.94820497334648 +-157.15204,56.7469347,13.719616,-192398.487893946,753387.79122712,34.1390380859375,20,1.53325128011044,-2.12620983735008 +-157.09144,56.7484946,13.719616,-188694.102277177,753387.775586778,54.0739097595215,20,1.7329877719355,-1.40070988857084 +-157.03084,56.7500242,13.53585432,-184990.031064567,753387.770523635,38.318675994873,20,1.58341049471615,-1.94401725303695 +-156.97024,56.7515235,13.719616,-181286.268109903,753387.775310039,39.0956764221191,121,1.59212873156877,-1.91235012835568 +-156.90963,56.7529926,13.719616,-177582.196841908,753387.773639969,137.02490234375,121,2.1367995012271,0.0660495715588112 +-156.84902,56.7544314,13.71403491,-173878.421556106,753387.781523588,31.2375221252441,121,1.49467657674133,-2.26632417030323 +-156.7884,56.75584,13.719616,-170174.325699177,753387.783799828,72.7985992431641,121,1.86212302290072,-0.931653798194954 +-156.72778,56.7572182,13.719616,-166470.514002136,753387.784242633,138.300308227539,121,2.1408231480151,0.0806646051559423 +-156.66715,56.7585662,13.719616,-162766.369451202,753387.77998354,139.987899780273,121,2.14609049792275,0.0997971234718956 +-156.60652,56.7598839,13.719616,-159062.496296623,753387.78485724,148.755096435547,121,2.17247185383534,0.195621738135063 +-156.54588,56.7611713,13.719616,-155358.278448945,753387.774842951,129.761535644531,121,2.11314597649408,-0.0198667816596285 +-156.48524,56.7624285,13.719616,-151654.319270467,753387.784986765,121.478340148926,121,2.08449884919052,-0.123921324730353 +-156.42459,56.7636553,13.719616,-147950.003514724,753387.770112243,137.7548828125,121,2.13910700165044,0.0744310717225767 +-156.36394,56.7648518,13.719616,-144245.934531795,753387.764178299,188.678741455078,121,2.27572297070628,0.570659265413139 +-156.30329,56.7660181,13.719616,-140542.105776349,753387.777766323,183.595169067383,121,2.26386124944158,0.527574108107426 +-156.24264,56.767154,13.719616,-136838.511873012,753387.788018674,187.809463500977,121,2.27371747207655,0.563374721963643 +-156.18197,56.7682596,13.719616,-133133.926394099,753387.765451113,184.998092651367,121,2.26716725080703,0.539582448693483 +-156.12131,56.7693349,13.719616,-129430.172983793,753387.771351133,223.590957641602,220,2.34945423604013,0.838472266104022 +-156.06064,56.7703799,13.719616,-125726.0256097,753387.765670158,250.490386962891,220,2.39879106366003,1.01767770615209 +-155.99997,56.7713946,13.719616,-122022.088043974,753387.767957244,284.996551513672,220,2.45483960503432,1.22126200626993 +-155.9393,56.772379,13.719616,-118318.354122794,753387.777728838,306.372192382812,220,2.48624934437196,1.33535114477641 +-155.87862,56.7733331,13.719616,-114614.207746384,753387.777257516,294.602478027344,220,2.46923639555846,1.27355525870674 +-155.81794,56.7742568,13.719616,-110910.252989857,753387.773308427,288.688049316406,220,2.46042880596813,1.2415635793783 +-155.75726,56.7751503,13.719616,-107206.483066022,753387.78774879,282.327697753906,220,2.45075348668965,1.20642005814778 +-155.69657,56.7760134,13.719616,-103502.282473421,753387.782259503,274.628936767578,220,2.43874629552413,1.16280651264106 +-155.63588,56.7768461,13.719616,-99798.2549489596,753387.773128883,267.842254638672,220,2.42787909212639,1.12333372809179 +-155.57519,56.7776486,13.719616,-96094.3937644522,753387.782269102,259.529815673828,220,2.41418725828771,1.07360107955127 +-155.51449,56.7784207,13.719616,-92390.0833552021,753387.773075966,248.140670776367,220,2.3946979518827,1.0028103558864 +-155.45379,56.7791625,13.719616,-88685.9272118691,753387.771363433,240.399932861328,220,2.38093434204136,0.952816996417275 +-155.39309,56.7798739,13.719616,-84981.9193982251,753387.765622056,229.499206542969,220,2.36078118837173,0.879614990006444 +-155.33239,56.7805551,13.719616,-81278.053265118,753387.777823742,211.156173706055,121,2.32460378368788,0.748208330135359 +-155.27169,56.7812058,13.719616,-77574.3233126569,753387.77417593,176.703048706055,121,2.24724404257295,0.467215669737498 +-155.21098,56.7818263,13.719616,-73870.1127621816,753387.776712807,130.795257568359,121,2.11659199743449,-0.00734985001175285 +-155.15027,56.7824164,13.719616,-70166.0257934385,753387.775064674,88.2862548828125,22,1.94589309436797,-0.627376988267031 +-155.08956,56.7829761,13.719616,-66462.0562028371,753387.768949496,75.071533203125,22,1.87547528565268,-0.883154568764596 +-155.02885,56.7835056,13.719616,-62758.1974406051,753387.780413472,71.2167358398438,22,1.85258206426619,-0.966309283216258 +-154.96814,56.7840046,13.719616,-59054.4438514075,753387.775733506,51.2876434326172,22,1.71001274453811,-1.48416174580387 +-154.90742,56.7844734,13.719616,-55350.1788072079,753387.779807582,45.7000007629395,22,1.65991620732019,-1.66612666795467 +-154.8467,56.7849117,13.719616,-51646.0065257917,753387.768390569,41.3748626708984,22,1.61673656530051,-1.82296745246698 +-154.78598,56.7853198,13.719616,-47941.9203746969,753387.77474484,35.8655166625977,22,1.55467709146865,-2.04838517496166 +-154.72526,56.7856975,13.719616,-44237.9144527951,753387.77636096,35.4954605102539,22,1.55017281498728,-2.0647459927905 +-154.66454,56.7860448,13.719616,-40533.9825537209,753387.773058361,34.529224395752,22,1.53818682322556,-2.10828253601173 +-154.60382,56.7863618,13.719616,-36830.1183693665,753387.775828787,45.6497573852539,22,1.65943847373175,-1.6678619327066 +-154.5431,56.7866484,13.719616,-33126.3158146481,753387.773363142,75.2694549560547,22,1.87661877121649,-0.879001102813588 +-154.48237,56.7869047,13.719616,-29421.9586662003,753387.772252007,60.7725601196289,22,1.78370753192751,-1.21648124341906 +-154.42165,56.7871307,13.719616,-25718.2606175026,753387.781791442,62.7138557434082,22,1.79736350268268,-1.1668788598342 +-154.36092,56.7873262,13.719616,-22013.9957425697,753387.771254608,56.7098159790039,22,1.75365823802074,-1.32562885581085 +-154.3002,56.7874915,13.719616,-18310.3775219792,753387.78120961,49.5576934814453,22,1.69511108520219,-1.53828882586897 +-154.23947,56.7876263,13.719616,-14606.1800594569,753387.772031292,41.3699188232422,22,1.61668466871633,-1.82315595567347 +-154.17874,56.7877309,13.719616,-10902.0069613869,753387.780444521,49.1003684997559,22,1.69108475152847,-1.55291361900196 +-153.81438,56.7877205,13.719616,11321.6455198441,753387.771144938,45.8891448974609,30,1.66170996508681,-1.65961122775685 +-153.75365,56.7876126,13.719616,15025.8210259961,753387.778257568,73.5810394287109,30,1.86676591851774,-0.914789476099587 +-153.69292,56.7874743,13.719616,18730.0216714063,753387.780651947,75.0749740600586,30,1.8754951908134,-0.883082267539352 +-153.6322,56.7873056,13.719616,22433.6437289684,753387.775016166,53.737663269043,30,1.73027877762703,-1.41054972912318 +-153.57147,56.7871066,13.719616,26137.9132048657,753387.778787199,65.5561828613281,30,1.81661365797771,-1.09695680126127 +-153.51075,56.7868772,13.719616,29841.6164881718,753387.7735883,73.1999969482422,30,1.86451106295236,-0.922979755112895 +-153.45002,56.7866175,13.719616,33545.9795643391,753387.779116249,84.4014511108398,30,1.92634991349784,-0.698363399366487 +-153.3893,56.7863274,13.719616,37249.7888424707,753387.774792468,113.356117248535,130,2.05444496174174,-0.23308562217783 +-153.32858,56.786007,13.719616,40953.6603520519,753387.776406812,156.257125854492,130,2.19383983176791,0.27323633301428 +-153.26786,56.7856562,13.719616,44657.6003923871,753387.772954601,138.6513671875,130,2.14192415634489,0.0846637816688169 +-153.20714,56.7852751,13.719616,48361.6150368999,753387.775760968,129.076309204102,130,2.11084653873366,-0.0282189959303685 +-153.14642,56.7848636,13.719616,52065.7106047231,753387.77385045,109.419609069824,130,2.03909515881358,-0.28884048768286 +-153.0857,56.7844218,13.719616,55769.8931482488,753387.778576916,80.3558044433594,31,1.90501725317993,-0.775849710588596 +-153.02499,56.7839496,13.719616,59473.5590712059,753387.770038728,76.0677261352539,31,1.88120043424277,-0.862359194965287 +-152.96427,56.7834471,13.719616,63177.9342751364,753387.776971495,67.8738403320312,31,1.83170242246133,-1.04215010189463 +-152.90356,56.7829143,13.719616,66881.8050640421,753387.781146384,65.0874710083008,31,1.81349739723742,-1.10827594973938 +-152.84285,56.7823511,13.719616,70585.7877413341,753387.780616491,62.5581512451172,31,1.79628390571823,-1.17080026415673 +-152.78214,56.7817575,13.719616,74289.8885110175,753387.775650971,60.7592124938965,31,1.78361213629392,-1.21682774758892 +-152.72144,56.7811336,13.719616,77993.5034266772,753387.765945543,67.5622863769531,31,1.82970433811763,-1.04940771454099 +-152.66073,56.7804794,13.719616,81697.8585310317,753387.774728186,75.5404663085938,31,1.87817966138407,-0.87333150420252 +-152.60003,56.7797949,13.719616,85401.740125721,753387.778265,112.792999267578,130,2.05228214509225,-0.240941589578107 +-152.53933,56.77908,13.719616,89105.7645626548,753387.777471074,150.868515014648,130,2.17859861563974,0.217875885760548 +-152.47863,56.7783348,13.719616,92809.9377876256,753387.783843208,166.295608520508,130,2.22088078066574,0.371456777666428 +-152.41794,56.7775592,13.719616,96513.6563014913,753387.772048995,171.438278198242,130,2.2341077963168,0.41950107387721 +-152.35725,56.7767533,13.719616,100217.535963569,753387.767030999,148.961654663086,130,2.1730744877985,0.197810676698098 +-152.29656,56.7759171,13.719616,103921.5829428,753387.769173451,109.228446960449,130,2.0383357587813,-0.291598845354455 +-152.23587,56.7750506,13.719616,107625.803407452,753387.778875,106.266944885254,130,2.02639819503677,-0.334959484194491 +-152.17519,56.7741537,13.719616,111329.593896519,753387.768631121,102.400001525879,130,2.0102999631113,-0.393432857440652 +-152.11451,56.7732265,13.719616,115033.570225813,753387.765672031,89.9558563232422,130,1.95402944212378,-0.597823450873043 +-152.05383,56.772269,13.719616,118737.738561447,753387.770439661,67.0841293334961,31,1.82661978755891,-1.06061168258864 +-151.99316,56.7712812,13.719616,122441.495133622,753387.764953434,57.913387298584,31,1.76277896714476,-1.29249976431712 +-151.93248,56.7702631,13.719616,126146.065977158,753387.78600025,63.5881271362305,31,1.80337603387843,-1.14503963038396 +-151.87182,56.7692146,13.719616,129849.627807879,753387.765928897,80.4722061157227,31,1.90564590751251,-0.773566258616869 +-151.81115,56.7681359,13.719616,133554.015889263,753387.784527968,135.565643310547,31,2.13214963930091,0.0491599458401464 +-151.75049,56.7670268,13.719616,137258.017238245,753387.780344564,298.362701416016,134,2.47474453065833,1.29356237756773 +-151.68984,56.7658875,13.719616,140961.637270389,753387.774537382,515.656982421875,330,2.71236090283187,2.15665286376694 +-134.25581,55.1205325,13.719616,1241049.83754848,753387.787228046,241,351,2.38201704257487,0.956749673788491 +-134.20031,55.110774,13.719616,1244753.70436738,753387.748531031,194,151,2.28780172993023,0.614532766535627 +-134.14483,55.1009888,13.719616,1248458.08893301,753387.870228969,175,151,2.24303804868629,0.451938299431001 +-134.08939,55.0911769,13.719616,1252161.7753822,753387.775656419,168,151,2.22530928172586,0.387542357536829 +-134.03397,55.0813383,13.719616,1255865.98758684,753387.840113195,165,151,2.21748394421391,0.359118498119706 +-133.97859,55.071473,13.719616,1259569.50967282,753387.684717618,149,151,2.17318626841227,0.198216695792707 +-133.92323,55.0615812,13.719616,1263273.55887171,753387.708272052,127,151,2.10380372095596,-0.0538005203193092 +-133.8679,55.0516627,13.719616,1266977.53582775,753387.699187996,138,151,2.13987908640124,0.07723550391239 +-133.81259,55.0417176,13.719616,1270682.05112352,753387.858216273,117,151,2.06818586174616,-0.183174751318448 +-133.75732,55.0317459,13.719616,1274385.8888366,753387.802033586,106,151,2.02530586526477,-0.338927137708368 +-133.70208,55.0217477,13.719616,1278089.65949464,753387.730832793,108,151,2.03342375548695,-0.309440643344858 +-133.64686,55.011723,13.719616,1281793.97694335,753387.83641923,107,151,2.02938377768521,-0.324114995845246 +-133.59168,55.0016717,13.719616,1285497.62858501,753387.721524896,96,151,1.98227123303957,-0.495241205257244 +-133.53652,54.991594,13.719616,1289201.83146345,753387.79276083,90,151,1.95424250943932,-0.597049529567529 +-133.48139,54.9814897,13.719616,1292905.98628131,753387.83471664,106,151,2.02530586526477,-0.338927137708368 +-133.42629,54.971359,13.719616,1296610.09016615,753387.867429629,125,151,2.09691001300806,-0.0788404352462293 +-133.37123,54.9612019,13.719616,1300313.53703982,753387.69392454,146,151,2.16435285578444,0.166131219821422 +-133.31619,54.9510183,13.719616,1304017.55403523,753387.693472718,211,151,2.32428245529769,0.74704117370595 +-133.26118,54.9408084,13.719616,1307721.52824969,753387.690865494,164,151,2.2148438480477,0.349528915285568 +-133.20619,54.9305721,13.719616,1311426.07686133,753387.871818153,112,151,2.04921802267018,-0.252071356802685 +-133.15124,54.9203094,13.26779406,1315129.98383492,753387.840796571,86.6568222045898,50,1.93780275896196,-0.656763395673257 +-133.09632,54.9100203,10.72560757,1318833.86293515,753387.793570988,53.3312606811523,50,1.72698184995696,-1.42252511145772 +-157.51228,56.703789,13.719616,-214622.330669121,749683.783727502,29.4633045196533,20,1.4692814544607,-2.35856650291601 +-157.45177,56.7055288,13.719616,-210918.065046444,749683.766121426,58.4358940124512,20,1.76667969271089,-1.27833121568304 +-157.39126,56.7072384,13.719616,-207214.149543619,749683.768020673,45.0064353942871,20,1.65327461725095,-1.69025081878467 +-157.33074,56.7089179,13.719616,-203509.967003629,749683.769114443,39.1670227050781,20,1.5929205597557,-1.9094739823705 +-157.27022,56.710567,13.719616,-199806.123491213,749683.766936627,51.9190864562988,20,1.71532704221915,-1.46485869977477 +-157.20969,56.712186,13.719616,-196102.000727959,749683.764606799,55.6500282287598,20,1.74546538896887,-1.35538762203919 +-157.14916,56.7137748,13.719616,-192398.20365726,749683.780858309,81.4656600952148,20,1.91097458083865,-0.754210996141549 +-157.08862,56.7153333,13.719616,-188694.116194824,749683.77537962,76.2252044677734,20,1.88209859799782,-0.859096807845497 +-157.02808,56.7168615,13.719616,-184990.342691655,749683.776958828,93.0949249267578,20,1.96892600604707,-0.543714878801014 +-156.96753,56.7183596,13.719616,-181286.265514958,749683.779864712,69.3624267578125,121,1.84112427923589,-1.00792722882377 +-156.90698,56.7198274,13.719616,-177582.490050681,749683.789507883,55.8927040100098,121,1.74735512067727,-1.34852357709115 +-156.84642,56.7212649,13.719616,-173878.399660392,749683.779008598,102.835258483887,121,2.01214204403309,-0.386741893750473 +-156.78585,56.7226723,13.719616,-170173.987261541,749683.771652054,118.857833862305,121,2.07502781114665,-0.158322838209077 +-156.72529,56.7240493,13.719616,-166470.469126184,749683.785134221,128.825820922852,121,2.11000291861713,-0.0312832649867542 +-156.66471,56.7253961,13.719616,-162766.006701032,749683.765896161,156.817184448242,121,2.19539365211192,0.278880252008201 +-156.60414,56.7267127,13.719616,-159062.425345077,749683.7884987,172.074981689453,121,2.23571773201238,0.425348819844932 +-156.54356,56.7279989,13.719616,-155358.498806323,749683.781558304,192.87158203125,121,2.28526824280098,0.605330418152972 +-156.48297,56.729255,13.719616,-151654.219650802,749683.779584403,161.358764648438,121,2.20779256028887,0.323916625507588 +-156.42238,56.7304807,13.719616,-147950.193499773,749683.772482806,173.804550170898,121,2.24006114201049,0.441125324690731 +-156.36179,56.7316762,13.719616,-144246.413374973,749683.781970282,188.903594970703,121,2.27624022293551,0.572538073148167 +-156.30119,56.7328414,13.719616,-140542.263045281,749683.775165877,185.37873840332,121,2.26805992223772,0.542824886123526 +-156.24059,56.7339764,13.719616,-136838.346470947,749683.784944408,193.225448608398,121,2.28606432426559,0.608222013256721 +-156.17998,56.735081,13.719616,-133134.047764803,749683.768416756,203.168228149414,121,2.30785579308905,0.687374847927981 +-156.11937,56.7361554,13.719616,-129429.970519059,749683.768522529,239.382247924805,220,2.37909194091518,0.946124869653373 +-156.05876,56.7371995,13.719616,-125726.108951085,749683.773599185,264.760955810547,220,2.42285394026062,1.10508094219419 +-155.99815,56.7382133,13.719616,-122022.456901019,749683.783149793,295.544189453125,220,2.47062242532168,1.27858971441903 +-155.93753,56.7391968,13.719616,-118318.397715293,749683.778875746,299.607849121094,220,2.47655318681557,1.30013193297269 +-155.8769,56.7401501,13.719616,-114613.924917094,749683.773135299,293.015930175781,220,2.46689123195606,1.26503695512647 +-155.81628,56.741073,13.719616,-110910.253970652,749683.778242858,282.213012695312,220,2.45057703497282,1.20577913514793 +-155.75565,56.7419656,13.719616,-107206.157401672,749683.770953106,273.7822265625,220,2.43740525111582,1.15793545657789 +-155.69502,56.742828,13.719616,-103502.239254478,749683.779253357,266.318267822266,220,2.42540095743519,1.11433243556331 +-155.63439,56.74366,13.719616,-99798.4939442289,749683.780425177,254.303421020508,220,2.40535220256791,1.04150963540097 +-155.57375,56.7444618,13.719616,-96094.3042535302,749683.781911083,251.091323852539,220,2.39983170646814,1.02145761786016 +-155.51311,56.7452332,13.719616,-92390.2750483293,749683.776605457,238.176513671875,220,2.37689893394948,0.938159242407422 +-155.45247,56.7459743,13.719616,-88686.3998875412,749683.775295236,232.308563232422,220,2.36606521882324,0.89880809681878 +-155.39182,56.7466852,13.719616,-84982.0618773357,749683.775986297,217.74528503418,121,2.33794875974947,0.796681092226448 +-155.33118,56.7473657,13.719616,-81278.4763135719,749683.782180258,186.967041015625,121,2.27176505484338,0.556282985297421 +-155.27053,56.7480159,13.719616,-77574.4157981997,749683.779672943,137.214492797852,121,2.13739998461945,0.0682306986348522 +-155.20988,56.7486358,13.719616,-73870.4846552543,749683.780951036,99.466911315918,121,1.99767863227489,-0.439277133524968 +-155.14922,56.7492254,13.719616,-70166.0662225134,749683.775153743,82.0215682983398,22,1.91392806898467,-0.743483084185749 +-155.08857,56.7497847,13.719616,-66462.3753158799,749683.783688809,76.4091720581055,22,1.88314549385231,-0.855294183288163 +-155.02791,56.7503136,13.719616,-62758.1849519819,749683.774560163,60.3003692626953,22,1.78031997164695,-1.22878582926404 +-154.96725,56.7508122,13.719616,-59054.0992598656,749683.769237348,46.3981971740723,22,1.66650110614619,-1.64220843590137 +-154.90659,56.7512806,13.719616,-55350.1119160368,749683.77863952,38.3888816833496,22,1.58420546075443,-1.94112970948 +-154.84593,56.7517186,13.719616,-51646.2170637466,749683.780230151,35.4549446105957,22,1.54967681123555,-2.06654761999037 +-154.78527,56.7521262,13.719616,-47942.4085004719,749683.773800113,33.3271560668945,22,1.52279825524015,-2.16417820726932 +-154.7246,56.7525036,13.719616,-44238.0692870047,749683.774807784,31.7615394592285,22,1.50190154420988,-2.24008102624643 +-154.66394,56.7528506,13.719616,-40534.4144901541,749683.774639448,32.4240760803223,22,1.5108676097697,-2.20751371696325 +-154.60327,56.7531673,13.719616,-36830.2168193363,749683.771521947,29.3225421905518,22,1.46720161983906,-2.3661210559057 +-154.5426,56.7534537,13.719616,-33126.0805942533,749683.771965623,32.2956848144531,22,1.50914449798228,-2.21377255080025 +-154.48193,56.7537098,13.719616,-29421.9996414853,749683.775833983,71.5972442626953,22,1.85489630688136,-0.957903293487352 +-154.42126,56.7539355,13.719616,-25717.9678581659,749683.771847363,68.759033203125,22,1.83732976159413,-1.02170999996178 +-154.36059,56.7541309,13.719616,-22013.9789792997,749683.771055639,66.5747680664062,22,1.82330966211578,-1.07263500300196 +-154.29992,56.754296,13.719616,-18310.0268308703,749683.773365675,53.6910629272461,22,1.72990200181886,-1.41191828640097 +-154.23925,56.7544308,13.719616,-14606.105238727,749683.77869878,55.0115928649902,22,1.74045422016264,-1.37358961747337 +-154.17858,56.7545352,13.71457969,-10902.2080585888,749683.775832916,35.8090744018555,22,1.55399309545028,-2.0508696437323 +-153.81455,56.7545249,13.66927602,11321.6198146389,749683.77606964,17.6095199584961,30,1.24574751711334,-3.17050556629945 +-153.75388,56.754417,13.719616,15025.5194718478,749683.771573013,21.9949607849121,30,1.34232319200456,-2.81971514965255 +-153.6932,56.7542788,13.719616,18730.0546967635,749683.772862025,60.8865699768066,30,1.78452150891897,-1.21352464665395 +-153.63253,56.7541103,13.719616,22434.0106778959,749683.77491972,111.885101318359,130,2.04877225948628,-0.253690495920077 +-153.57186,56.7539115,13.719616,26138.004082269,749683.780088973,110.242889404297,130,2.0423505873275,-0.277015842128512 +-153.51119,56.7536823,13.719616,29842.0411659949,749683.777307004,94.9970626831055,30,1.97771017707579,-0.511808262372668 +-153.45053,56.7534228,13.719616,33545.5175482775,749683.772789483,82.68212890625,30,1.91741165034922,-0.730829722356572 +-153.38986,56.753133,13.719616,37249.6603884842,749683.77620481,83.297966003418,30,1.92063439679362,-0.719123787407106 +-153.32919,56.7528128,13.719616,40953.8654798375,749683.772040362,118.182624816895,130,2.07255363136064,-0.167309765393094 +-153.26853,56.7524624,13.719616,44657.5282873938,749683.77603888,129.943542480469,130,2.11375470219192,-0.0176557161774574 +-153.20786,56.7520816,13.719616,48361.8762053679,749683.778944133,154.711776733398,130,2.1895233736584,0.257557725120739 +-153.1472,56.7516705,13.719616,52065.6943078833,749683.77808822,140.602920532227,130,2.1479943417212,0.10671242755896 +-153.08654,56.751229,13.719616,55769.5994135278,749683.769234759,86.6483612060547,31,1.93776035324846,-0.656917425328494 +-153.02588,56.7507573,13.719616,59473.5973974647,749683.774907719,75.2064437866211,31,1.87625505310599,-0.880322230806385 +-152.96522,56.7502552,13.719616,63177.6947483419,749683.773018558,86.4990844726562,31,1.93701151081074,-0.659637434803216 +-152.90456,56.7497228,13.719616,66881.8974838233,749683.774963265,64.9488067626953,31,1.81257117663865,-1.11164024732381 +-152.84391,56.7491601,13.719616,70585.6012817438,749683.770366889,63.7675094604492,31,1.80459945527005,-1.14059581469035 +-152.78325,56.7485671,13.719616,74290.0332981172,749683.780197028,66.3046493530273,31,1.82154398266674,-1.07904845473594 +-152.7226,56.7479438,13.719616,77993.9787169853,749683.782921211,70.4368515014648,31,1.84779993494288,-0.983679341874134 +-152.66195,56.7472901,13.719616,81698.0544253066,749683.77830954,79.4211959838867,31,1.89993642270887,-0.794304737072893 +-152.60131,56.7466062,13.719616,85401.6556595863,749683.776124977,115.027412414551,130,2.06080135028146,-0.209997404707651 +-152.54066,56.7458919,13.719616,89106.0100335748,749683.779543988,149.321746826172,130,2.17412306183644,0.201619396896736 +-152.48002,56.7451473,13.719616,92809.9025043872,749683.7737854,165.304260253906,130,2.21828404643848,0.362024697771278 +-152.41938,56.7443725,13.719616,96513.9494664271,749683.783217999,178.653137207031,130,2.25201064695738,0.484529337386086 +-152.35875,56.7435673,13.719616,100217.547114149,749683.770810923,139.789199829102,130,2.14547361893603,0.0975564429173367 +-152.29811,56.7427318,13.719616,103921.922343751,749683.777725741,109.704650878906,130,2.04022503968254,-0.284736437866688 +-152.23748,56.741866,13.719616,107625.860334616,749683.77362154,101.323692321777,130,2.00571100746825,-0.410101254154572 +-152.17685,56.74097,13.719616,111329.97743779,749683.785154563,90.7136306762695,31,1.95767254927306,-0.584590645860578 +-152.11623,56.7400436,13.719616,115033.669926471,749683.773122761,71.3746719360352,31,1.85354412508302,-0.962814803730057 +-152.05561,56.7390869,13.719616,118737.554160425,749683.765326945,50.9528961181641,31,1.70716887396348,-1.4944914954524 +-151.99499,56.7381,13.719616,122441.635965057,749683.773375105,53.7069206237793,31,1.73003025208804,-1.41145244481703 +-151.93437,56.7370827,13.719616,126145.922165221,749683.775431627,62.3202056884766,31,1.79462887806025,-1.17681179700241 +-151.87376,56.7360352,13.719616,129849.807744848,749683.774733054,83.6564483642578,134,1.92249942265739,-0.712349481138505 +-151.81315,56.7349574,13.719616,133553.909693388,749683.779062357,111.397880554199,134,2.04687692806956,-0.260574880607079 +-151.75255,56.7338493,13.719616,137257.623676863,749683.768264532,418.991058349609,231,2.62220475482582,1.82918000108237 +-134.27281,55.0887235,13.719616,1241049.53609467,749683.70210826,268,351,2.42813479402879,1.12426251038591 +-134.21735,55.0789726,13.719616,1244753.52734668,749683.690474098,188,151,2.27415784926368,0.564974297603475 +-134.16191,55.0691951,13.719616,1248458.029879,749683.847064034,178,151,2.25042000230889,0.478751662007618 +-134.10651,55.0593909,13.719616,1252161.82997183,749683.784559894,163,151,2.21218760440396,0.339880680204086 +-134.05114,55.0495601,13.719616,1255865.53882552,749683.6997847,155,151,2.19033169817029,0.260493790466696 +-133.99579,55.0397026,13.719616,1259569.77420572,749683.770524533,146,151,2.16435285578444,0.166131219821422 +-133.94047,55.0298185,13.719616,1263273.92629847,749683.817632319,135,151,2.13033376849501,0.0425641847719837 +-133.88518,55.0199078,13.719616,1266977.99906267,749683.839877809,135,151,2.13033376849501,0.0425641847719837 +-133.82992,55.0099705,13.719616,1270681.99645174,749683.836037987,118,151,2.07188200730613,-0.169749295659684 +-133.77469,55.0000067,13.719616,1274385.91907546,749683.815517127,110,151,2.04139268515822,-0.280495216219808 +-133.71949,54.9900163,13.719616,1278089.77419694,749683.766480669,106,151,2.02530586526477,-0.338927137708368 +-133.66432,54.9799994,13.719616,1281793.56239751,749683.6983413,93,151,1.96848294855394,-0.545324190077275 +-133.60917,54.969956,13.719616,1285497.89807529,749683.803462632,120,151,2.07918124604762,-0.143236377140402 +-133.55406,54.9598862,13.719616,1289201.5607711,749683.704680902,116,151,2.06445798922692,-0.19671544834909 +-133.49897,54.9497898,13.719616,1292905.78210272,749683.767278858,113,151,2.05307844348342,-0.238049206535204 +-133.44391,54.9396671,13.719616,1296609.94532023,749683.82832355,92,151,1.96378782734556,-0.562378210427123 +-133.38888,54.9295179,13.719616,1300314.06105348,749683.865423267,101,151,2.00432137378264,-0.415148800341636 +-133.33389,54.9193423,13.719616,1304017.51927932,749683.691650729,183,151,2.26245108973043,0.522452005536869 +-133.27892,54.9091403,13.719616,1307721.54482976,749683.697989067,191,151,2.28103336724773,0.589948141389748 +-133.22398,54.8989119,13.719616,1311425.53105267,749683.687477215,177,151,2.24797326636181,0.46986441867983 +-133.16906,54.8886572,13.719616,1315130.08884191,749683.867574897,131,151,2.11727129565576,-0.0048824449810836 +-133.11418,54.8783762,13.719616,1318834.00101543,749683.841623745,120,151,2.07918124604762,-0.143236377140402 +-133.05933,54.8680689,12.72855491,1322537.88186434,749683.805942939,83.3744354248047,50,1.92103290608236,-0.717676287924529 +-157.75082,56.6633815,11.21730182,-229438.097173608,745979.773114499,41.8162307739258,20,1.62134488386523,-1.80622872409484 +-157.44863,56.6723748,13.21606678,-210918.367425619,745979.784846362,28.7814102172852,20,1.45911206946788,-2.39550461184139 +-157.38817,56.6740829,13.719616,-207214.150221831,745979.770233233,81.3622741699219,20,1.91042307911878,-0.756214207802376 +-157.32771,56.6757609,13.719616,-203510.275994771,745979.78304059,115.647537231445,20,2.0631363887004,-0.201515878683765 +-157.26724,56.6774086,13.719616,-199806.12871847,745979.770102718,83.2601013183594,20,1.92043693503956,-0.719841024859054 +-157.20677,56.6790262,13.719616,-196102.312231603,745979.784127557,134.136764526367,20,2.1275478266409,0.0324448487708865 +-157.14629,56.6806135,13.719616,-192398.210464956,745979.773091168,99.6763229370117,20,1.99859200847219,-0.43595949047286 +-157.08581,56.6821707,13.719616,-188694.427295181,745979.788616457,157.082824707031,20,2.19612870227273,0.281550163996453 +-157.02532,56.6836976,13.719616,-184990.34660991,745979.779821343,150.362991333008,20,2.17714095701581,0.212581253581267 +-156.96482,56.6851944,13.719616,-181285.961273261,745979.769946076,37.793815612793,121,1.57742073991725,-1.96577375211278 +-156.90433,56.6866609,13.719616,-177582.488281642,745979.791143318,92.0752944946289,121,1.96414311658139,-0.561087698512918 +-156.84382,56.6880972,13.719616,-173878.087863131,745979.773644093,102.032028198242,121,2.00873651966767,-0.399111730279099 +-156.78331,56.6895033,13.719616,-170173.976005769,745979.771363053,131.051940917969,121,2.11744345735985,-0.00425710453198867 +-156.7228,56.6908791,13.719616,-166470.14705253,745979.772486181,148.070526123047,121,2.17046861952047,0.18834541932345 +-156.66228,56.6922247,13.719616,-162765.983359726,745979.762999336,156.747055053711,121,2.19519939010283,0.278174636943295 +-156.60176,56.6935401,13.719616,-159062.089861414,745979.767889082,163.258255004883,121,2.21287515020701,0.342378042805881 +-156.54124,56.6948253,13.719616,-155358.460439957,745979.786531881,168.274993896484,121,2.22601958347645,0.390122376235281 +-156.48071,56.6960802,13.719616,-151654.478342722,745979.78433342,189.816360473633,121,2.27833364200701,0.58014196873715 +-156.42017,56.6973049,13.719616,-147950.137013011,745979.773520426,193.467330932617,121,2.28660764018943,0.610195491769903 +-156.35963,56.6984993,13.719616,-144246.041777053,745979.765755514,186.555389404297,121,2.27080779990452,0.552805962131733 +-156.29909,56.6996635,13.719616,-140542.186096493,745979.771621559,190.306900024414,121,2.27945453494074,0.584213371807152 +-156.23854,56.7007975,13.719616,-136837.952798058,745979.769961708,194.896774291992,121,2.28980465123265,0.621807948396684 +-156.17799,56.7019012,13.719616,-133133.947174627,745979.770807086,218.598754882812,220,2.33964768392172,0.802852069741287 +-156.11744,56.7029746,13.719616,-129430.163071209,745979.773633088,249.111907958984,220,2.39639448802334,1.00897265938884 +-156.05688,56.7040178,13.719616,-125725.982935814,745979.77014981,279.426544189453,220,2.446267659643,1.19012625393186 +-155.99632,56.7050307,13.719616,-122022.012028157,745979.768757101,298.464660644531,220,2.47489291638448,1.29410135687862 +-155.93576,56.7060134,13.719616,-118318.243865506,745979.780125878,300.832489013672,220,2.47832473696423,1.3065667087634 +-155.87519,56.7069658,13.719616,-114614.061584372,745979.77537875,287.873931884766,220,2.45920233958744,1.23710870341528 +-155.81462,56.7078879,13.719616,-110910.070076199,745979.772436589,277.543548583984,220,2.44333113674106,1.17945996458491 +-155.75405,56.7087798,13.719616,-107206.262886406,745979.782014262,264.687286376953,220,2.42273308150181,1.10464194868568 +-155.69347,56.7096413,13.719616,-103502.023403181,745979.765796069,258.362915039062,220,2.41223017592622,1.06649239780742 +-155.63289,56.7104727,13.719616,-99797.9556623277,745979.773533724,246.099700927734,220,2.39111108592745,0.989781834943474 +-155.57231,56.7112737,13.719616,-96094.0543552027,745979.771370839,241.084350585938,220,2.38216902010472,0.957301699555629 +-155.51173,56.7120445,13.719616,-92390.3127806422,745979.781234462,231.258911132812,220,2.3640984764651,0.891664327209856 +-155.45114,56.712785,13.719616,-88686.1139989607,745979.778249865,217.440399169922,121,2.33734023665265,0.794470762649028 +-155.39055,56.7134952,13.719616,-84982.0628967798,745979.776534365,194.802215576172,121,2.28959389200376,0.62104241072067 +-155.32996,56.7141751,13.719616,-81278.1533095218,745979.775750054,142.838638305664,121,2.15484570136984,0.131598521375579 +-155.26937,56.7148247,13.719616,-77574.3790720376,745979.775573446,100.965217590332,121,2.0041717855623,-0.415692147454658 +-155.20877,56.7154441,13.719616,-73870.1227649533,745979.77572774,81.1534652709961,22,1.90930706902905,-0.760267874989267 +-155.14817,56.7160332,13.719616,-70165.9894961088,745979.777001768,73.7083892822266,22,1.86751692085265,-0.912061621261767 +-155.08757,56.7165919,13.719616,-66461.9732815109,745979.767959315,66.6954879760742,22,1.82409645440569,-1.06977714883214 +-155.02697,56.7171204,13.719616,-62758.0675783993,745979.770646032,55.923755645752,22,1.74759632943034,-1.34764743805214 +-154.96637,56.7176186,13.719616,-59054.266412056,745979.773654686,40.3653450012207,22,1.60600866873536,-1.86193423483816 +-154.90576,56.7180865,13.719616,-55349.952563834,745979.768413708,38.5232963562012,22,1.58572344169387,-1.93561596943307 +-154.84516,56.7185242,13.719616,-51646.3418245632,745979.783083567,30.9484825134277,22,1.49063935926239,-2.28098849652334 +-154.78455,56.7189315,13.719616,-47942.2062183791,745979.77903189,28.3359603881836,22,1.45233793673119,-2.42011019547104 +-154.72394,56.7193085,13.719616,-44238.1504745936,745979.77555565,23.1809616088867,22,1.36513144770916,-2.73686905480914 +-154.66333,56.7196552,13.719616,-40534.1684237541,745979.772475385,28.6558456420898,22,1.45721322913557,-2.40240174191134 +-154.60272,56.7199717,13.719616,-36830.2537948542,745979.780782994,26.0817260742188,22,1.41633632937979,-2.55087830925311 +-154.54211,56.7202578,13.719616,-33126.4006305744,745979.778014043,25.9623336791992,22,1.41434372735972,-2.55811600853523 +-154.48149,56.7205136,13.719616,-29421.9915985987,745979.770758864,23.8098697662354,22,1.37675701993407,-2.6946416582196 +-154.42088,56.7207392,13.719616,-25718.2425589581,745979.779471237,22.6687412261963,22,1.3554274048334,-2.77211690834348 +-154.36026,56.7209344,13.719616,-22013.9253913477,745979.773426596,53.7466087341309,22,1.73035106664313,-1.41028715478337 +-154.29965,56.7210993,13.719616,-18310.2559452522,745979.770876514,59.119140625,22,1.77172811238723,-1.25999391445614 +-154.23903,56.721234,13.719616,-14606.0059082825,745979.77682792,23.3794937133789,22,1.3688351022122,-2.72341632452587 +-154.17842,56.7213383,13.719616,-10902.3913010483,745979.773858491,27.1537380218506,22,1.43382962363087,-2.48733767144992 +-153.87533,56.7214055,12.4970951,7617.97695867115,745979.776871911,21.3944034576416,30,1.33030018151094,-2.86338615547425 +-153.81472,56.721328,13.719616,11321.5751701304,745979.772471675,51.7902183532715,30,1.71424774205518,-1.46877902603323 +-153.7541,56.7212203,13.719616,15025.803261302,745979.780925991,130.29704284668,30,2.11493455930474,-0.0133701383789753 +-153.69348,56.7210822,13.719616,18730.0564252243,745979.77882438,144.452346801758,130,2.15972460187267,0.149320080578682 +-153.63287,56.7209138,13.719616,22433.7297512606,745979.774011924,152.277389526367,130,2.18263542314619,0.232538722843583 +-153.57225,56.7207151,13.719616,26138.0515116251,745979.772767122,154.14501953125,130,2.18792949711288,0.251768310569725 +-153.51164,56.7204862,13.719616,29841.8056938734,745979.779027877,154.268035888672,130,2.18827595020302,0.253026727080683 +-153.45103,56.7202269,13.719616,33545.6096731925,745979.773966925,90.4406509399414,30,1.9563636794872,-0.589344834511433 +-153.39041,56.7199373,13.719616,37250.0805987919,745979.774473872,93.9758834838867,30,1.97301641728421,-0.528857337668118 +-153.3298,56.7196175,13.719616,40954.0024270833,745979.781183172,114.920257568359,130,2.0603965906961,-0.211467607051574 +-153.26919,56.7192673,13.719616,44657.9925936788,745979.776984573,149.952697753906,130,2.1759542834273,0.208270916397408 +-153.20858,56.7188869,13.719616,48362.057032921,745979.784358328,150.055282592773,130,2.17625128906782,0.209349725657659 +-153.14798,56.7184761,13.719616,52065.5911193527,745979.773332245,150.53059387207,130,2.17762477500978,0.21433861863076 +-153.08737,56.7180351,13.719616,55769.8228471933,745979.781537056,99.3824157714844,130,1.99730954929695,-0.440617748247621 +-153.02677,56.7175637,13.719616,59473.5365804267,745979.770632306,101.999732971191,31,2.0085990348081,-0.399611114531178 +-152.96616,56.7170621,13.719616,63177.9602718337,745979.780507892,87.1442794799805,31,1.94023888345038,-0.64791469619217 +-152.90556,56.7165302,13.719616,66881.8781414884,745979.781777681,70.6537857055664,31,1.84913543677184,-0.978828418041172 +-152.84496,56.7159679,13.719616,70585.9076016075,745979.772494545,66.3456954956055,31,1.82181275111683,-1.07807221101109 +-152.78436,56.7153754,13.719616,74290.0544413944,745979.775237592,72.0811004638672,31,1.85782140840576,-0.94727848984366 +-152.72377,56.7147527,13.719616,77993.7137463446,745979.778544085,83.7311401367188,31,1.92288700487979,-0.710941671879785 +-152.66318,56.7140996,13.719616,81697.5031518405,745979.771028249,94.0403518676758,31,1.97331424544125,-0.527775540793134 +-152.60258,56.7134162,13.719616,85402.0396699062,745979.777015887,109.605163574219,130,2.03983101454038,-0.286167649649003 +-152.542,56.7127026,13.719616,89105.4960688457,745979.769408066,148.384811401367,130,2.17138944904165,0.191690134975309 +-152.48141,56.7119587,13.719616,92809.7118895979,745979.775967939,171.194076538086,130,2.23348873363945,0.417252461534987 +-152.42082,56.7111845,13.719616,96514.0822454714,745979.784189876,170.998931884766,130,2.23299339765531,0.415453259857609 +-152.36024,56.71038,13.719616,100218.002249154,745979.779351618,104.450302124023,130,2.01890970052127,-0.36215983370393 +-152.29966,56.7095453,13.719616,103922.088828291,745979.786964552,97.7102279663086,130,1.98994002653184,-0.467385958401718 +-152.23909,56.7086802,13.719616,107625.737655349,745979.76891217,87.2710800170898,31,1.94087035058068,-0.64562102733626 +-152.17852,56.707785,13.719616,111329.565054836,745979.774156517,66.216423034668,31,1.82096571676242,-1.08114888155397 +-152.11795,56.7068594,13.719616,115033.578074745,745979.769663318,46.6567649841309,31,1.66891462305081,-1.63344185361747 +-152.05738,56.7059036,13.719616,118737.782252804,745979.778178525,43.4688262939453,31,1.63817791392112,-1.74508635430674 +-151.99682,56.7049175,13.719616,122441.573003452,745979.77056666,49.4660568237305,31,1.69430729205108,-1.54120843201919 +-151.93626,56.7039011,13.719616,126145.567535594,745979.764618046,64.9418411254883,31,1.81252459687553,-1.11180943831863 +-151.8757,56.7028545,13.719616,129849.771649883,745979.771967399,95.5605545043945,134,1.98027866114377,-0.502478795119433 +-151.81515,56.7017777,13.719616,133553.580421833,745979.773001129,245.621368408203,134,2.39026614658184,0.98671277407052 +-134.28977,55.0569104,13.719616,1241049.94877875,745979.821380037,543,351,2.73479982958885,2.23815745045562 +-134.23435,55.0471673,13.719616,1244754.05430074,745979.859228172,187,151,2.2718416065365,0.556561042896859 +-134.17896,55.0373975,13.719616,1248458.06010503,745979.863846672,183,151,2.26245108973043,0.522452005536869 +-134.1236,55.027601,13.719616,1252161.97019874,745979.833978251,159,151,2.20139712432045,0.300686576631144 +-134.06827,55.0177779,13.719616,1255865.78529229,745979.779008006,156,151,2.19312459835446,0.27063840110868 +-134.01297,55.0079281,13.719616,1259569.51265554,745979.687052557,149,151,2.17318626841227,0.198216695792707 +-133.95769,54.9980518,13.719616,1263273.76071216,745979.768355388,131,151,2.11727129565576,-0.0048824449810836 +-133.90244,54.9881489,13.719616,1266977.92566174,745979.821939816,133,151,2.12385164096709,0.0190192474071795 +-133.84722,54.9782194,13.719616,1270682.01145778,745979.846576291,122,151,2.08635983067475,-0.117161708802643 +-133.79203,54.9682634,13.719616,1274386.01871312,745979.8516629,118,151,2.07188200730613,-0.169749295659684 +-133.73687,54.9582808,13.719616,1278089.95468803,745979.825358178,112,151,2.04921802267018,-0.252071356802685 +-133.68174,54.9482718,13.719616,1281793.81661411,745979.787683223,102,151,2.00860017176192,-0.399606984790377 +-133.62664,54.9382362,13.719616,1285497.61509351,745979.7161962,102,151,2.00860017176192,-0.399606984790377 +-133.57156,54.9281742,13.719616,1289201.95836252,745979.825045196,114,151,2.05690485133647,-0.224150601047379 +-133.51652,54.9180858,13.719616,1292905.62818814,745979.725334262,123,151,2.0899051114394,-0.10428423714156 +-133.4615,54.9079709,13.719616,1296609.85392217,745979.794070011,93,151,1.96848294855394,-0.545324190077275 +-133.40651,54.8978296,13.719616,1300314.02500106,745979.846545986,75,151,1.8750612633917,-0.8846584157902 +-133.35156,54.887662,13.719616,1304017.53082092,745979.695819793,171,151,2.23299611039215,0.415463113292133 +-133.29663,54.8774679,13.719616,1307721.60413108,745979.711671443,198,151,2.29666519026153,0.646727384342376 +-133.24173,54.8672475,13.719616,1311425.63090283,745979.718323931,202,151,2.30535136944662,0.678278066425006 +-133.18686,54.8570008,13.719616,1315129.61494558,745979.714605257,181,151,2.25767857486918,0.505116869349467 +-133.13202,54.8467278,13.719616,1318833.56006328,745979.699350245,169,151,2.22788670461367,0.396904293135091 +-133.0772,54.8364285,13.719616,1322538.08110504,745979.870544719,174,151,2.2405492482826,0.442898265990424 +-133.02242,54.8261029,12.26130846,1326241.95976267,745979.829306282,85.6610488891602,50,1.932783387875,-0.674995184132261 +-132.96767,54.8157511,6.048505649,1329945.80740835,745979.783652291,14.8402223587036,50,1.17144040824992,-3.44041019505185 +-157.86813,56.6264288,13.71867451,-236845.957409016,742275.763629168,17.6200218200684,20,1.24600644189268,-3.1695650775964 +-157.80777,56.6283464,13.71646193,-233141.93268331,742275.756226093,33.2813529968262,20,1.52220097348141,-2.16634770509825 +-157.74741,56.630234,13.719616,-229438.292335762,742275.785317581,42.606990814209,20,1.62948086255218,-1.77667652726434 +-157.44549,56.6392194,8.422861772,-210918.320935529,742275.776815917,44.4347724914551,20,1.6477229608977,-1.71041601926015 +-157.38509,56.6409261,12.27860672,-207214.418609361,742275.78831275,30.3190498352051,20,1.48171558687449,-2.31340218493441 +-157.32468,56.6426026,13.719616,-203510.24775161,742275.781906476,25.0913372039795,20,1.39952380698358,-2.6119461893678 +-157.26427,56.6442489,13.719616,-199806.413870553,742275.788563966,60.0856704711914,20,1.77877091164825,-1.23441245732506 +-157.20385,56.645865,13.719616,-196102.299256421,742275.777978155,161.84294128418,20,2.20909376256973,0.328642963591784 +-157.14343,56.647451,13.719616,-192398.508886964,742275.791172788,174.843872070312,20,2.24265041575487,0.450530305982613 +-157.083,56.6490068,13.719616,-188694.425597959,742275.787841601,140.626419067383,20,2.14806691796228,0.106976045181888 +-157.02256,56.6505324,13.719616,-184990.043284116,742275.768921864,137.786560058594,20,2.1392068577962,0.0747937777457559 +-156.96212,56.6520278,13.719616,-181285.967447257,742275.7626626,144.114562988281,20,2.15870786912685,0.145627017041467 +-156.90168,56.6534931,13.719616,-177582.191492329,742275.779502144,87.6005783081055,121,1.94250697323646,-0.639676346711853 +-156.84123,56.6549281,13.719616,-173878.098686785,742275.770273602,96.3535766601562,121,1.98386784037123,-0.48944187171156 +-156.78078,56.656333,13.719616,-170174.293564402,742275.783887692,149.623184204102,121,2.17499889293878,0.204800665447541 +-156.72032,56.6577076,13.719616,-166470.15934974,742275.772319576,170.41960144043,121,2.23151954528885,0.41009980738329 +-156.65986,56.6590521,13.719616,-162766.300614886,742275.783394741,140.716232299805,121,2.14834419829911,0.107983206508938 +-156.59939,56.6603663,13.719616,-159062.100541594,742275.770230512,155.986724853516,121,2.19308763958405,0.270504156305452 +-156.53892,56.6616504,13.719616,-155358.163740368,742275.779567055,147.798416137695,121,2.169669780024,0.185443806260777 +-156.47845,56.6629042,13.719616,-151654.484958599,742275.788499688,190.117080688477,121,2.27902113693652,0.582639146551748 +-156.41797,56.6641278,13.719616,-147950.446034727,742275.785304757,199.793899536133,121,2.3005822234383,0.660955166872981 +-156.35748,56.6653212,13.719616,-144246.040851121,742275.771075944,184.950866699219,121,2.26705637080581,0.539179700880747 +-156.297,56.6664844,13.719616,-140542.486505877,742275.789246097,191.262145996094,121,2.28162902433068,0.592111737932492 +-156.2365,56.6676173,13.719616,-136837.942430028,742275.764626327,207.950256347656,121,2.31795946007149,0.724074250281876 +-156.17601,56.6687201,13.719616,-133134.236566681,742275.782467766,238.703125,220,2.377858104643,0.941643224140882 +-156.11551,56.6697926,13.719616,-129430.140318884,742275.779294995,264.698425292969,220,2.42275135766475,1.10470833292599 +-156.05501,56.6708348,13.719616,-125726.259142237,742275.775203486,287.376617431641,220,2.45845142860847,1.23438118040832 +-155.9945,56.6718469,13.719616,-122021.974604746,742275.773628106,299.228546142578,220,2.47600302248397,1.29813357908779 +-155.934,56.6728287,13.719616,-118318.504479348,742275.789091272,289.747375488281,220,2.46201951084402,1.24734147351991 +-155.87348,56.6737802,13.719616,-114614.007785736,742275.767678546,278.881927490234,220,2.44542037139916,1.1870486611901 +-155.81297,56.6747015,13.719616,-110910.312888397,742275.773538793,267.728485107422,220,2.42769458062601,1.1226635296576 +-155.75245,56.6755926,13.719616,-107206.190444312,742275.772276412,254.785415649414,220,2.40617456461991,1.04449668909934 +-155.69193,56.6764535,13.719616,-103502.245934789,742275.78072723,251.278961181641,220,2.40015612796696,1.022636009343 +-155.63141,56.6772841,13.719616,-99798.473506123,742275.787329577,241.397048950195,220,2.38273195659613,0.959346445570484 +-155.57088,56.6780844,13.719616,-96094.2553910301,742275.777219194,232.396789550781,220,2.36623012419157,0.899407080185228 +-155.51035,56.6788545,13.719616,-92390.1967845526,742275.776754939,218.620758056641,220,2.33969139586367,0.803010843991104 +-155.44982,56.6795943,13.719616,-88686.2918005043,742275.774417353,198.270217895508,121,2.29725748387241,0.648878763794509 +-155.38928,56.6803039,13.719616,-84981.9224363019,742275.768212961,154.096755981445,121,2.18779349612149,0.251274316150455 +-155.32875,56.6809832,13.719616,-81278.3060009322,742275.772801032,107.115249633789,121,2.02985130426181,-0.322416805873659 +-155.26821,56.6816323,13.719616,-77574.2129026395,742275.773978586,82.2697143554688,22,1.91523998941682,-0.738717814716818 +-155.20767,56.6822511,13.719616,-73870.2488206211,742275.773079024,74.9894714355469,22,1.87500029247943,-0.884879879546381 +-155.14713,56.6828397,13.719616,-70166.4073991124,742275.780963524,65.6029586791992,22,1.81692342640423,-1.09583163391945 +-155.08658,56.683398,13.719616,-66462.0710792578,742275.776189686,50.6730995178223,22,1.70477746956238,-1.50317775881197 +-155.02604,56.683926,13.719616,-62758.4569137489,742275.77906527,41.0786819458008,22,1.61361650033788,-1.83430041896648 +-154.96549,56.6844238,13.719616,-59054.33535923,742275.781037399,35.2967948913574,22,1.54773527127469,-2.07359984729888 +-154.90494,56.6848913,13.719616,-55350.3120417204,742275.780721666,32.8981018066406,22,1.51717084023922,-2.18461858477688 +-154.84439,56.6853285,13.719616,-51646.3807959478,742275.777895813,30.5738735198975,22,1.48535046462558,-2.30019927144505 +-154.78383,56.6857355,13.719616,-47941.923716247,742275.776289174,24.786584854126,22,1.39421669291623,-2.63122314246158 +-154.72328,56.6861122,13.719616,-44238.1580053722,742275.779548054,27.652925491333,22,1.44174108347196,-2.45860099115159 +-154.66273,56.6864586,13.719616,-40534.465888675,742275.779716617,27.0147609710693,22,1.43160112921725,-2.49543219923579 +-154.60217,56.6867747,13.719616,-36830.2295912097,742275.771084327,22.8910369873047,22,1.35966546710282,-2.75672305651756 +-154.54161,56.6870606,13.719616,-33126.0544634776,742275.771318814,21.8999996185303,22,1.34044410727527,-2.82654052173353 +-154.48105,56.6873162,13.719616,-29421.9344497143,742275.769127673,18.2889499664307,22,1.26218877180361,-3.11078623646311 +-154.4205,56.6875416,13.719616,-25718.4749202997,742275.779418715,18.1512832641602,22,1.25890733432213,-3.12270535401133 +-154.35994,56.6877367,13.719616,-22014.4465819983,742275.782625243,18.3265933990479,22,1.26308174453172,-3.1075427046348 +-154.29938,56.6879014,13.719616,-18310.4549257661,742275.77192792,20.6567516326904,22,1.3150620277879,-2.91873547919841 +-154.23882,56.688036,13.719616,-14606.4936328777,742275.78071907,27.8326873779297,22,1.44455514154995,-2.44837952900021 +-154.17825,56.6881402,13.44718988,-10901.9450779047,742275.773822395,20.8782958984375,22,1.31969504834807,-2.90190702612815 +-153.93601,56.6882545,13.719616,3913.68305718441,742275.781150116,34.6313018798828,30,1.5394688181051,-2.10362596469148 +-153.87545,56.6882073,13.719616,7617.59097409219,742275.772707937,75.8751983642578,30,1.88009983948219,-0.866356869276732 +-153.81489,56.6881299,13.719616,11321.5115525206,742275.772452043,108.829010009766,30,2.03674467852209,-0.297378102995418 +-153.75432,56.6880222,13.719616,15026.0625796981,742275.771524763,122.075439453125,130,2.08662829635345,-0.116186564829875 +-153.69376,56.6878843,13.719616,18730.0269555208,742275.777166862,120.551223754883,31,2.08117162340111,-0.136006758482269 +-153.6332,56.6877161,13.719616,22434.0224873866,742275.779991758,124.60612487793,31,2.09553939011859,-0.0838189287955004 +-153.57264,56.6875176,13.719616,26138.0553431192,742275.780079446,153.169387817383,130,2.18517197658621,0.241752208942142 +-153.51209,56.6872888,13.719616,29841.5200820437,742275.773030816,152.13037109375,130,2.18221592464945,0.23101498456663 +-153.45153,56.6870298,13.719616,33545.645996223,742275.778540537,116.373390197754,130,2.06585368640127,-0.191645877840194 +-153.39097,56.6867405,13.719616,37249.8277163968,742275.781639249,106.067443847656,130,2.02558210277989,-0.337923764207424 +-153.33041,56.6864209,13.719616,40954.0714096505,742275.782464523,130.094329833984,130,2.11425836823356,-0.0158262573536226 +-153.26986,56.686071,13.719616,44657.7716344584,742275.774443842,149.696273803711,130,2.17521099014514,0.205571063039598 +-153.20931,56.6856909,13.719616,48361.5460328991,742275.774508767,151.082656860352,130,2.17921461349759,0.220113365803552 +-153.14875,56.6852805,13.719616,52066.0124920727,742275.779523518,151.350402832031,130,2.17998358120601,0.222906476005777 +-153.0882,56.6848398,13.719616,55769.953961218,742275.7745611,146.139190673828,130,2.16476669787122,0.167634412402919 +-153.02765,56.6843689,13.719616,59473.9880509309,742275.778268986,115.016067504883,130,2.06075851462559,-0.210152996036284 +-152.96711,56.6838677,13.719616,63177.5094610853,742275.770201846,89.1154403686523,31,1.94995295752678,-0.612630406473917 +-152.90656,56.6833363,13.719616,66881.7473895264,742275.780221949,68.9241485595703,31,1.83837140984253,-1.01792643620759 +-152.84602,56.6827745,13.719616,70585.4851411612,742275.766686871,68.9537887573242,31,1.83855813405346,-1.01724820057709 +-152.78547,56.6821826,13.719616,74289.9515150867,742275.78402887,71.4749069213867,31,1.85415359846788,-0.960601022435214 +-152.72493,56.6815603,13.719616,77993.9300396619,742275.777248618,82.4886093139648,31,1.91639398183927,-0.734526184856238 +-152.66439,56.6809078,13.719616,81698.0380680138,742275.779580422,89.0001754760742,31,1.949390862917,-0.614672094534406 +-152.60386,56.6802251,13.719616,85401.6701237683,742275.778474203,117.454971313477,130,2.06987140313423,-0.177052383895589 +-152.54332,56.679512,13.719616,89106.056044463,742275.777106762,150.853408813477,130,2.17855512831383,0.217717927380346 +-152.48279,56.6787688,13.719616,92809.9780406683,742275.783002684,170.855072021484,130,2.23262787583743,0.414125580284758 +-152.42226,56.6779953,13.719616,96514.0543505792,742275.787065869,159.948638916016,130,2.20398054880413,0.310070311738618 +-152.36174,56.6771915,13.719616,100217.679526005,742275.774573302,82.5436630249023,31,1.91668373757512,-0.733473709319104 +-152.30121,56.6763575,13.719616,103922.082657812,742275.786683472,70.3244781494141,31,1.84710651811885,-0.986198029699879 +-152.24069,56.6754932,13.719616,107626.04695318,742275.781900063,52.8078308105469,31,1.72269832832246,-1.438084084673 +-152.18018,56.6745987,13.719616,111329.578264587,742275.770113125,37.1562690734863,31,1.57003209923592,-1.9926114039954 +-152.11966,56.6736739,13.719616,115033.90625155,742275.773564118,38.6994819641113,31,1.58770515154001,-1.92841783363561 +-152.05915,56.672719,13.719616,118737.813202055,742275.780911222,47.4700584411621,31,1.6764197663857,-1.60618103084399 +-151.99864,56.6717337,13.719616,122441.917827945,742275.775914693,54.9490585327148,31,1.73996025585779,-1.37538383682005 +-151.93814,56.6707183,13.719616,126145.613667519,742275.773502965,70.3952484130859,134,1.84754334582364,-0.984611346793028 +-151.87764,56.6696726,13.719616,129849.5191355,742275.769733369,119.948577880859,134,2.07899510330713,-0.14391250070431 +-151.81714,56.6685967,13.719616,133553.640018756,742275.776253209,515.333801269531,231,2.71208862921326,2.15566388826952 +-134.36212,55.0348022,13.719616,1237345.52184196,742275.6931347,224,351,2.35024801833416,0.841355509963957 +-134.30671,55.0250934,13.719616,1241049.85199163,742275.793962864,207,251,2.31597034545692,0.716849218251904 +-134.25133,55.0153579,13.719616,1244754.07466606,742275.86001927,182,251,2.26007138798507,0.513808249563239 +-134.19599,55.0055958,13.719616,1248457.5789987,742275.712684417,198,151,2.29666519026153,0.646727384342376 +-134.14067,54.995807,13.719616,1252161.59546649,742275.715468819,171,151,2.23299611039215,0.415463113292133 +-134.08538,54.9859916,13.719616,1255865.51317439,742275.690319709,153,151,2.1846914308176,0.240006729549137 +-134.03011,54.9761496,13.719616,1259569.94770061,742275.825641945,151,151,2.17897694729317,0.219250094312423 +-133.97488,54.966281,13.719616,1263273.67979287,742275.74141743,139,151,2.14301480025409,0.0886253116478125 +-133.91967,54.9563858,13.719616,1266977.93662688,742275.816285966,130,151,2.11394335230684,-0.0169704851139895 +-133.8645,54.9464641,13.719616,1270681.49561596,742275.678636697,137,151,2.13672056715641,0.0657628604840208 +-133.80935,54.9365159,13.719616,1274385.58389863,742275.709345994,124,151,2.09342168516224,-0.0915110376501457 +-133.75423,54.9265412,13.719616,1278089.59378291,742275.716405255,119,151,2.07554696139253,-0.156437136335818 +-133.69914,54.9165399,13.719616,1281793.5325296,742275.687976165,115,151,2.06069784035361,-0.21037338231028 +-133.64407,54.9065123,13.719616,1285498.00560311,742275.848254096,102,151,2.00860017176192,-0.399606984790377 +-133.58904,54.8964581,13.719616,1289201.80373627,742275.777609036,94,151,1.9731278535997,-0.528452569163169 +-133.53404,54.8863775,13.719616,1292905.53570618,742275.689068974,102.728820800781,151,2.01169230298173,-0.38837548161791 +-133.47906,54.8762706,13.719616,1296609.8135994,742275.787273013,121,151,2.08278537031645,-0.130145169076543 +-133.42411,54.8661372,13.719616,1300314.03642594,742275.855690262,137,151,2.13672056715641,0.0657628604840208 +-133.3692,54.8559774,13.719616,1304017.59305349,742275.707381089,140,151,2.14612803567824,0.0999334713141587 +-133.31431,54.8457913,13.719616,1307721.70713449,742275.74390976,202,151,2.30535136944662,0.678278066425006 +-133.25945,54.8355789,13.719616,1311425.77087566,742275.768293157,206,151,2.31386722036915,0.709210067641479 +-133.20462,54.8253402,13.719616,1315129.78808666,742275.779352735,212,151,2.32633586092875,0.754499729058273 +-133.14982,54.8150751,13.719616,1318833.76600867,742275.765331518,204,151,2.3096301674259,0.693819881976265 +-133.09505,54.8047838,13.719616,1322537.70157518,742275.746238042,193,151,2.28555730900777,0.60638038912377 +-133.04031,54.7944662,13.719616,1326241.60200777,742275.710325838,140,151,2.14612803567824,0.0999334713141587 +-132.98559,54.7841224,13.60209703,1329946.07923966,742275.86727932,190.003036499023,151,2.27876054160668,0.581692589932455 +-132.93091,54.7737524,10.43958215,1333649.91381052,742275.815982957,89.9745635986328,50,1.95411974888243,-0.597495430949509 +-157.92492,56.5913371,13.71505321,-240550.427802245,738571.783962931,13.8999996185303,20,1.14301478833538,-3.54366016006115 +-157.86462,56.5932832,13.7161636,-236846.341007434,738571.780026643,27.5700645446777,20,1.44043778284007,-2.46333495104566 +-157.80431,56.5951992,13.719616,-233142.032589654,738571.763686638,31.3541812896729,20,1.49629546510118,-2.2604439057035 +-157.744,56.5970851,13.719616,-229438.108659852,738571.770262332,39.0184516906738,20,1.59127003195912,-1.91546917043521 +-157.62336,56.6007665,12.54573426,-222030.166312187,738571.77061834,31.7896957397461,20,1.50228637128748,-2.23868322446 +-157.56303,56.6025621,13.24615023,-218326.135158041,738571.77603458,34.9240417480469,20,1.5431244987019,-2.09034748932877 +-157.44235,56.6060628,13.719616,-210917.924368299,738571.765271793,40.3353118896484,20,1.60568541944012,-1.86310836854298 +-157.38201,56.6077679,13.719616,-207214.344731871,738571.780873899,52.215015411377,20,1.71779541052296,-1.45589288155285 +-157.32166,56.6094429,13.719616,-203510.494949541,738571.786171508,34.130428314209,20,1.53314173842017,-2.12660772403549 +-157.2613,56.6110878,13.719616,-199806.368954654,738571.782048355,66.609130859375,20,1.82353376685848,-1.07182099061061 +-157.20093,56.6127026,13.719616,-196101.960679222,738571.769402304,150.525543212891,20,2.17761020315329,0.214285689488781 +-157.14057,56.6142871,13.719616,-192398.489440882,738571.78479971,190.323013305664,20,2.27949130508881,0.584346931480185 +-157.08019,56.6158416,13.719616,-188694.111058276,738571.774010295,209.776733398438,20,2.32175731838087,0.737869155678219 +-157.01981,56.6173659,13.719616,-184990.044836367,738571.773070463,153.327987670898,20,2.18562143588256,0.243384773394946 +-156.95943,56.61886,13.719616,-181286.284671683,738571.781259843,119.393081665039,20,2.07697916195459,-0.151234975103672 +-156.89904,56.6203239,13.719616,-177582.212293452,738571.77113243,94.5796279907227,20,1.97579760147583,-0.51875528285514 +-156.83865,56.6217577,13.719616,-173878.433285172,738571.780997562,93.2100677490234,121,1.96946282363837,-0.541765004086422 +-156.77825,56.6231614,13.719616,-170174.329404118,738571.784554385,96.3848648071289,121,1.98400884254594,-0.488929711566985 +-156.71785,56.6245348,13.719616,-166470.50765147,738571.785586735,118.469276428223,121,2.07360573593498,-0.163488221278554 +-156.65744,56.6258781,13.719616,-162766.348828827,738571.781229518,123.715202331543,121,2.09242306974258,-0.0951382938875664 +-156.59703,56.6271912,13.719616,-159062.459458446,738571.785325472,138.530899047852,121,2.14154665274555,0.0832925808457566 +-156.53661,56.6284741,13.719616,-155358.221262763,738571.773860093,158.564102172852,121,2.20020487281216,0.296355978850583 +-156.47619,56.6297269,13.719616,-151654.239879472,738571.781884025,201.000900268555,121,2.30319800259855,0.670456423400704 +-156.41577,56.6309494,13.719616,-147950.510036916,738571.786507984,203.539306640625,121,2.30864829075393,0.690253425648182 +-156.35534,56.6321418,13.719616,-144246.412632857,738571.787730784,192.538223266602,121,2.2845169598492,0.602601544034599 +-156.2949,56.6333039,13.719616,-140541.942353089,738571.764363305,189.082336425781,121,2.27665096009245,0.574029987738257 +-156.23447,56.6344359,13.719616,-136838.316632297,738571.781037233,224.728439331055,121,2.35165803576137,0.846477095718627 +-156.17403,56.6355377,13.719616,-133134.305416491,738571.784300384,255.474182128906,121,2.4073470174825,1.04875537254763 +-156.11359,56.6366092,13.719616,-129430.515108464,738571.783643053,275.428619384766,220,2.44000906516965,1.16739325242394 +-156.05314,56.6376506,13.719616,-125726.3267028,738571.781927602,295.047302246094,220,2.46989164803792,1.2759353227398 +-155.99269,56.6386617,13.719616,-122022.346945408,738571.776406344,288.453033447266,220,2.46007511047212,1.24027885638204 +-155.93223,56.6396427,13.719616,-118317.956869784,738571.771086964,280.371307373047,220,2.44773356675841,1.19545084698656 +-155.87178,56.6405934,13.719616,-114614.375345698,738571.779391796,269.714080810547,220,2.43090362001126,1.13431967665586 +-155.81132,56.6415139,13.719616,-110910.371583818,738571.776947733,258.005523681641,220,2.41162900394299,1.06430876957274 +-155.75085,56.6424042,13.719616,-107205.939460942,738571.764992119,253.026016235352,220,2.40316517780255,1.0335657372142 +-155.69039,56.6432643,13.719616,-103502.297185316,738571.77594673,238.908813476562,220,2.37823217140595,0.94300194139318 +-155.62992,56.6440942,13.719616,-99798.214300117,738571.777676334,230.693389892578,220,2.36303515076598,0.887802024767268 +-155.56945,56.6448938,13.719616,-96094.2971097365,738571.774777351,217.922576904297,220,2.33830222573517,0.797964981575738 +-155.50897,56.6456632,13.719616,-92389.9270381623,738571.764112017,194.982711791992,121,2.28999610620258,0.622503367494173 +-155.4485,56.6464024,13.719616,-88686.3222909511,738571.773697328,161.011154174805,121,2.20685596316707,0.320514637429809 +-155.38802,56.6471114,13.719616,-84982.2524086933,738571.775917145,111.166114807129,121,2.04597242757956,-0.263860284556892 +-155.32754,56.6477901,13.719616,-81278.3236526619,738571.773193185,82.7250671386719,121,1.91763712830022,-0.730010722080728 +-155.26705,56.6484387,13.719616,-77573.917272232,738571.775831306,76.0415267944336,22,1.88105082823208,-0.862902606697937 +-155.20657,56.6490569,13.719616,-73870.2521091923,738571.77398034,66.9057998657227,22,1.82546376710265,-1.06481067884686 +-155.14608,56.649645,13.719616,-70166.0970634093,738571.778006727,55.8797035217285,22,1.74725409323279,-1.3488905376056 +-155.08559,56.6502028,13.719616,-66462.058566261,738571.777003199,44.5160903930664,22,1.64851701560708,-1.70753178590993 +-155.0251,56.6507303,13.719616,-62758.1304568912,738571.770704883,35.9213485717773,22,1.55535263273601,-2.04593141625996 +-154.96461,56.6512277,13.719616,-59054.3062499086,738571.781172052,29.3882484436035,22,1.46817370264471,-2.36259017369554 +-154.90411,56.6516948,13.719616,-55349.9679822356,738571.777523951,25.2834777832031,22,1.40283681162664,-2.59991241087853 +-154.84362,56.6521316,13.719616,-51646.3338239417,738571.776765449,27.2635974884033,22,1.43558316134014,-2.48096832198035 +-154.78312,56.6525382,13.719616,-47942.1731488124,738571.773733694,26.731014251709,22,1.42701543745327,-2.5120887406093 +-154.72262,56.6529146,13.719616,-44238.0919906036,738571.776570448,25.9002208709717,22,1.4133034676579,-2.56189452869193 +-154.66212,56.6532607,13.719616,-40534.0843278963,738571.773941299,25.6772480010986,22,1.40954847570592,-2.57553373124294 +-154.60162,56.6535766,13.719616,-36830.1438961939,738571.77683799,28.7022171020508,22,1.45791544509625,-2.39985109310974 +-154.54112,56.6538622,13.719616,-33126.2646531867,738571.773954567,19.6102886199951,22,1.29248398556727,-3.0007453729586 +-154.48062,56.6541176,13.719616,-29422.4403541882,738571.776311686,18.2419185638428,22,1.26107051260381,-3.11484807305972 +-154.42011,56.6543428,13.719616,-25718.0526994353,738571.779915688,17.9863586425781,22,1.25494324886504,-3.13710404385412 +-154.35961,56.6545377,13.719616,-22014.3199476537,738571.781806307,17.2310218811035,22,1.23631103392885,-3.20478156666599 +-154.2991,56.6547023,13.719616,-18310.0116021298,738571.774703556,15.9268207550049,22,1.20212909241404,-3.32894013474523 +-154.2386,56.6548367,13.719616,-14606.3457902813,738571.775757698,21.331823348999,22,1.32902797858891,-2.86800715960992 +-154.17809,56.6549409,13.719616,-10902.0920456272,738571.779948567,19.7894439697266,22,1.29643359186825,-2.98639927554356 +-154.11759,56.6550148,13.719616,-7198.46858569696,738571.779911175,22.7427368164062,22,1.35684272564391,-2.76697605918696 +-154.05708,56.6550584,13.719616,-3494.24491334006,738571.772884893,25.2056179046631,22,1.40149734844333,-2.60477772348116 +-153.99657,56.6550718,13.719616,209.972969794172,738571.771647257,23.4153099060059,30,1.36949991012483,-2.72100155243212 +-153.93607,56.655055,13.719616,3913.57903215463,738571.77560255,46.4405784606934,30,1.66689762064282,-1.64076818207312 +-153.87556,56.6550079,13.719616,7617.8037613756,738571.774223099,79.7710571289062,30,1.90184534737539,-0.787370977822738 +-153.81505,56.6549306,13.719616,11322.0411253097,738571.778656243,89.1673126220703,31,1.95020567781162,-0.611712454265824 +-153.75455,56.654823,13.719616,15025.6851335669,738571.775519551,63.5249710083008,31,1.80294447551795,-1.14660717352823 +-153.69404,56.6546852,13.719616,18729.9662318156,738571.779987975,73.4752578735352,31,1.86614111897543,-0.917058926372777 +-153.63354,56.6545171,13.719616,22433.6662837295,738571.775887582,78.6920928955078,31,1.895931095963,-0.808853227047978 +-153.57303,56.6543188,13.719616,26138.0157144292,738571.780652886,148.104858398438,130,2.17056930525331,0.1887111386437 +-153.51253,56.6540902,13.719616,29841.7964076395,738571.77590781,149.416137695312,130,2.1743975060037,0.202616256446406 +-153.45203,56.6538314,13.719616,33545.6266017386,738571.776295179,128.01887512207,130,2.10727400681209,-0.0411954515716298 +-153.39153,56.6535423,13.719616,37249.5125325963,738571.770781549,118.613380432129,130,2.07413368329522,-0.161570565774992 +-153.33102,56.653223,13.719616,40954.0724178403,738571.776826932,143.695251464844,130,2.15744241673068,0.141030532742492 +-153.27052,56.6528735,13.719616,44658.0880584682,738571.782806993,146.222610473633,130,2.16501453298222,0.168534620265255 +-153.21003,56.6524937,13.719616,48361.5657201012,738571.776058416,146.977432250977,130,2.16725065582787,0.176656856693632 +-153.14953,56.6520836,13.719616,52065.7358980244,738571.770768204,151.864929199219,130,2.18145749200758,0.228260140733125 +-153.08903,56.6516434,13.719616,55769.9922828648,738571.782717677,150.727584838867,130,2.1781927403505,0.216401630861701 +-153.02854,56.6511728,13.719616,59473.7292995768,738571.769693568,106.370300292969,130,2.02682038529552,-0.33342596866963 +-152.96805,56.6506721,13.719616,63177.5647867413,738571.773225313,76.4998321533203,31,1.88366048227824,-0.853423598332873 +-152.90756,56.6501411,13.719616,66881.5052120927,738571.77123967,74.6975631713867,31,1.87330643423197,-0.891032456176451 +-152.84707,56.6495799,13.719616,70585.5565432107,738571.775143613,70.9450378417969,31,1.85092202469427,-0.972339020763949 +-152.78658,56.6489884,13.719616,74289.7251142578,738571.774048414,70.6398849487305,31,1.84904998323412,-0.979138809681048 +-152.72609,56.6483667,13.719616,77994.0168715828,738571.779389382,72.0116958618164,31,1.85740303859423,-0.948798128413748 +-152.66561,56.6477148,13.719616,81697.825778466,738571.779159233,91.4300231933594,31,1.96108882993684,-0.572181739386127 +-152.60513,56.6470326,13.719616,85401.7703641625,738571.773699166,124.202980041504,130,2.09413201613086,-0.0889309128234699 +-152.54465,56.6463202,13.719616,89105.8565429978,738571.77448683,155.106979370117,130,2.19063134026191,0.261582176069834 +-152.48417,56.6455776,13.719616,92810.0904427201,738571.781859723,170.00439453125,130,2.23046014782536,0.406251773413767 +-152.4237,56.6448048,13.719616,96513.8660244035,738571.781636809,95.502799987793,31,1.98001610458293,-0.503432475489506 +-152.36323,56.6440017,13.719616,100217.801855626,738571.776448405,68.9453353881836,31,1.83850488858728,-1.01744160330804 +-152.30276,56.6431684,13.719616,103921.90380767,738571.777828478,50.1911926269531,31,1.70062751537026,-1.5182515769526 +-152.2423,56.6423049,13.719616,107625.5658397,738571.769965678,36.9494438171387,31,1.56760790554639,-2.00141676740952 +-152.18183,56.6414112,13.719616,111330.018408463,738571.785123186,40.6251487731934,31,1.60879496441791,-1.85181361363115 +-152.12137,56.6404872,13.719616,115034.043621172,738571.779602554,47.4636268615723,31,1.67636092110815,-1.60639477368815 +-152.06092,56.6395331,13.719616,118737.646980008,738571.774472239,62.5902862548828,31,1.79650693779122,-1.16999014800792 +-152.00046,56.6385487,13.719616,122442.059580759,738571.783081131,65.4640579223633,31,1.81600292243041,-1.09917516709037 +-151.94001,56.6375341,13.719616,126146.062897267,738571.780731033,97.4501419067383,134,1.98878247587302,-0.471590512792416 +-151.87957,56.6364893,13.719616,129849.6630503,738571.766229042,309.655456542969,134,2.49087873726218,1.35216642111397 +-151.81912,56.6354144,13.719616,133554.090125676,738571.789767208,545.844909667969,231,2.73706926460359,2.24640068619041 +-134.37898,55.0029736,13.719616,1237346.02870225,738571.851353311,248,351,2.39445168082622,1.0019158291165 +-134.32362,54.9932724,13.719616,1241049.86393616,738571.797456387,237,251,2.3747483460101,0.930347693172715 +-134.26829,54.9835446,13.719616,1244753.58469213,738571.715508717,209,251,2.32014628611105,0.732017426639857 +-134.21298,54.9737901,13.719616,1248457.81039021,738571.781572054,204,151,2.3096301674259,0.693819881976265 +-134.1577,54.964009,13.719616,1252161.92959473,738571.818140764,184,151,2.26481782300954,0.531048656339518 +-134.10245,54.9542013,13.719616,1255865.94628099,738571.823943274,177,151,2.24797326636181,0.46986441867983 +-134.04723,54.944367,13.719616,1259569.86441887,738571.797715324,157,151,2.19589965240923,0.280718189514898 +-133.99204,54.9345061,13.719616,1263273.68797283,738571.738199914,134,151,2.12710479836481,0.0308356436192711 +-133.93687,54.9246187,13.719616,1266978.02975618,738571.845552434,140,151,2.14612803567824,0.0999334713141587 +-133.88174,54.9147048,13.719616,1270681.66936404,738571.737523034,147,151,2.16731733474818,0.176899053564259 +-133.82663,54.9047643,13.719616,1274385.83837988,738571.784360476,136,151,2.13353890837022,0.0542061676367513 +-133.77155,54.8947974,13.719616,1278089.92190408,738571.815294875,130,151,2.11394335230684,-0.0169704851139895 +-133.7165,54.884804,13.719616,1281793.92716835,738571.81847227,125,151,2.09691001300806,-0.0788404352462293 +-133.66148,54.8747841,13.719616,1285497.85807832,738571.792669855,122,151,2.08635983067475,-0.117161708802643 +-133.60649,54.8647378,13.719616,1289201.71516982,738571.747281335,100,151,2,-0.430845263363071 +-133.55153,54.8546651,13.719616,1292905.50231143,738571.681089153,25.189037322998,151,1.40121156990784,-2.60581575269137 +-133.49659,54.844566,13.719616,1296609.83553238,738571.788122768,119.288940429688,151,2.07660018102989,-0.152611541994123 +-133.44169,54.8344405,13.719616,1300313.4943582,738571.677256204,120,151,2.07918124604762,-0.143236377140402 +-133.38681,54.8242887,13.719616,1304017.70357413,738571.748928175,108,151,2.03342375548695,-0.309440643344858 +-133.33196,54.8141105,13.719616,1307721.85824273,738571.796105309,150,151,2.17609125905568,0.208768450976442 +-133.27714,54.803906,13.719616,1311425.95878879,738571.828196285,185,151,2.26717172840301,0.539598712600118 +-133.22235,54.7936752,13.719616,1315130.00902217,738571.844016056,204,151,2.3096301674259,0.693819881976265 +-133.16759,54.7834181,13.719616,1318834.0127473,738571.842386361,212,151,2.32633586092875,0.754499729058273 +-133.11286,54.7731348,13.719616,1322537.97032054,738571.832718363,203,151,2.30749603791321,0.686068114444982 +-133.05816,54.7628252,13.719616,1326241.88896075,738571.803258658,175,151,2.24303804868629,0.451938299431001 +-133.00349,54.7524894,13.719616,1329945.76899606,738571.763425825,167,151,2.22271647114758,0.378124529454699 +-132.94885,54.7421274,13.719616,1333649.61418314,738571.712059489,180,151,2.25527250510331,0.496377337199112 +-132.89423,54.7317393,11.48190603,1337354.0369621,738571.859951634,60.0411567687988,50,1.77844905088414,-1.23558154748853 +-157.80086,56.5620506,12.9257522,-233142.36079043,734867.779648789,38.3554306030273,20,1.5838268627819,-1.94250488537888 +-157.7406,56.5639349,13.719616,-229438.158185542,734867.774595325,35.4001274108887,20,1.54900482512597,-2.0689884653443 +-157.68034,56.565789,13.719616,-225734.334113989,734867.777988114,88.6594848632812,20,1.9477252035967,-0.620722244612238 +-157.62007,56.5676131,13.719616,-222030.268550885,734867.777798373,64.1719970703125,20,1.80734555500135,-1.13062119665139 +-157.55979,56.5694071,13.69886979,-218325.956067596,734867.763703453,47.1621780395508,20,1.67359385343569,-1.61644555327429 +-157.49951,56.571171,13.719616,-214622.003329867,734867.768849695,58.0297203063965,20,1.76365047734238,-1.2893341905256 +-157.43923,56.5729047,13.70565497,-210918.404855647,734867.781266471,42.8691177368164,20,1.63214454565257,-1.76700126995286 +-157.37893,56.5746084,13.719616,-207213.927971347,734867.760014884,54.5054359436035,20,1.7364398175534,-1.38817107357473 +-157.31864,56.576282,13.53819458,-203510.405373744,734867.788431437,70.2318420410156,20,1.84653405924296,-0.988277363733133 +-157.19802,56.5795388,7.195820963,-196101.910252947,734867.766596145,13.9800872802734,20,1.14550988279899,-3.53459726479843 +-157.07739,56.582675,9.357242045,-188694.096872084,734867.765345071,14.933497428894,20,1.17416153151542,-3.43052629866563 +-157.01707,56.584198,13.719616,-184990.353402761,734867.782075569,155.93586730957,20,2.19294602014737,0.269989754089234 +-156.95674,56.5856908,13.719616,-181286.30284749,734867.777101821,118.663887023926,20,2.07431857023937,-0.160899003621842 +-156.8964,56.5871535,13.719616,-177581.938618268,734867.762537412,140.704650878906,20,2.1483084529263,0.107853369112179 +-156.83607,56.5885861,13.719616,-173878.48009032,734867.79173057,113.455383300781,20,2.05482510738144,-0.231704824710088 +-156.77572,56.5899885,13.719616,-170174.083484698,734867.774313807,85.7608795166016,121,1.93328922625784,-0.673157834745133 +-156.71537,56.5913607,13.719616,-166469.968143944,734867.763104542,126.863403320312,121,2.10333635788445,-0.0554981163937293 +-156.65502,56.5927028,13.719616,-162766.127515953,734867.768601521,140.939865112305,121,2.14903385151622,0.11048822384014 +-156.59466,56.5940148,13.719616,-159061.942799957,734867.766220932,156.753463745117,121,2.19521714611373,0.27823913184295 +-156.5343,56.5952966,13.719616,-155358.0210674,734867.769263101,177.889038085938,121,2.2501491867266,0.477767982514269 +-156.47394,56.5965482,13.719616,-151654.356208842,734867.77712245,198.947982788086,121,2.29873954002202,0.654262014750831 +-156.41357,56.5977697,13.719616,-147950.328984647,734867.778078112,203.314163208008,220,2.30816763337898,0.688507540869093 +-156.35319,56.598961,13.719616,-144245.933708975,734867.762078362,196.941940307617,220,2.29433821235232,0.638275136390504 +-156.29282,56.6001222,13.719616,-140542.389331978,734867.783707562,211.857025146484,220,2.32604286971424,0.75343550133916 +-156.23244,56.6012532,13.719616,-136838.464697969,734867.788385711,233.799560546875,121,2.36884369052023,0.908900299077034 +-156.17205,56.602354,13.719616,-133134.153692647,734867.777251389,263.129791259766,220,2.42017002120343,1.09533218211172 +-156.11166,56.6034246,13.719616,-129430.06292464,734867.770946679,287.182769775391,220,2.45815837980444,1.23331674350762 +-156.05127,56.6044651,13.719616,-125726.185933346,734867.780116034,287.385070800781,220,2.45846420347376,1.23442758236538 +-155.99087,56.6054753,13.719616,-122021.904577194,734867.763592825,282.259185791016,220,2.45064808442671,1.20603720704401 +-155.93048,56.6064554,13.719616,-118318.437507179,734867.780506174,272.541839599609,220,2.43543318298849,1.15077234225517 +-155.87007,56.6074053,13.719616,-114613.940777776,734867.765793856,259.979064941406,220,2.41493837740741,1.07632935858476 +-155.80967,56.608325,13.719616,-110910.246441137,734867.772454731,250.332916259766,220,2.39851795871766,1.01668571104949 +-155.74926,56.6092146,13.719616,-107206.12263569,734867.777247103,241.519180297852,220,2.38295162604715,0.960144347716517 +-155.68885,56.6100739,13.719616,-103502.176562217,734867.774704492,229.327835083008,220,2.36045677121177,0.878436614283609 +-155.62844,56.610903,13.719616,-99798.4017952254,734867.775572279,216.947372436523,220,2.33635439452871,0.79088990266749 +-155.56802,56.611702,13.719616,-96094.1792252954,734867.776141528,198.724746704102,121,2.29825195210145,0.652490956251882 +-155.5076,56.6124707,13.719616,-92390.1159902899,734867.769313749,167.465484619141,121,2.2239253105724,0.382515379282747 +-155.44718,56.6132093,13.719616,-88686.2054500944,734867.777031317,109.231315612793,121,2.03834716445042,-0.291557416708726 +-155.38676,56.6139176,13.719616,-84982.4419769156,734867.776638195,88.3910064697266,121,1.9464080790485,-0.625506416916052 +-155.32633,56.6145958,13.719616,-81278.2062462011,734867.777867573,78.7723159790039,22,1.89637361431679,-0.807245874079692 +-155.2659,56.6152437,13.719616,-77574.1053122483,734867.771445184,67.9072341918945,22,1.83191604235514,-1.04137417346713 +-155.20547,56.6158615,13.719616,-73870.1326138414,734867.779372304,56.7277030944824,22,1.75379519933085,-1.32513137323989 +-155.14504,56.616449,13.719616,-70166.2824398025,734867.779048259,44.2169494628906,22,1.64558877720397,-1.71816798359247 +-155.0846,56.6170063,13.719616,-66461.9357268686,734867.771341343,37.4754409790039,22,1.57374675195717,-1.97911872504434 +-155.02417,56.6175334,13.719616,-62758.3117954462,734867.776560899,33.9506874084473,22,1.5308485719795,-2.13493715908285 +-154.96373,56.6180303,13.719616,-59054.17907018,734867.774999774,28.1532230377197,22,1.44952812094121,-2.43031624842153 +-154.90329,56.618497,13.719616,-55350.1441467934,734867.776430466,27.1677112579346,22,1.4340530528486,-2.48652611275805 +-154.84285,56.6189335,13.719616,-51646.200896791,734867.780632053,26.0817260742188,22,1.41633632937979,-2.55087830925311 +-154.78241,56.6193397,13.719616,-47942.3433227387,734867.776242528,25,22,1.39794000867204,-2.61769899689636 +-154.72196,56.6197158,13.719616,-44237.9522985919,734867.778718901,29,22,1.46239799789896,-2.38356918188237 +-154.66152,56.6200616,13.719616,-40534.2473951969,734867.779452569,21,22,1.32221929473392,-2.8927382427631 +-154.60107,56.6203772,13.719616,-36829.9969036525,734867.77667038,15,22,1.17609125905568,-3.42351697744033 +-154.54063,56.6206626,13.719616,-33126.4201415417,734867.781872237,12,22,1.07918124604762,-3.77552180555717 +-154.41973,56.6211427,13.719616,-25718.1997354649,734867.778490197,15.1000003814697,22,1.17897695826471,-3.41303529425259 +-154.35928,56.6213374,13.719616,-22014.1565337476,734867.775224631,12.014139175415,22,1.07969265863886,-3.77366420905412 +-154.23838,56.6216362,11.7227851,-14606.1733876292,734867.776239201,12.3860721588135,22,1.09293360579492,-3.72556930964073 +-154.17793,56.6217403,12.80734289,-10902.2211810097,734867.780377857,18,22,1.25527250510331,-3.13590809121766 +-154.11748,56.6218141,9.444241739,-7198.28706342507,734867.775710802,18,22,1.25527250510331,-3.13590809121766 +-154.05703,56.6218577,13.48960078,-3494.36486349425,734867.773359169,18.3923168182373,22,1.26463643929793,-3.10189560948986 +-153.99658,56.6218711,13.719616,209.551550171533,734867.77330231,40.5659561157227,30,1.60816171649997,-1.85411375081608 +-153.93612,56.6218543,13.719616,3914.08103281338,734867.776123214,41.3706893920898,30,1.61669275794376,-1.82312657329058 +-153.87567,56.6218073,13.719616,7618.00426817618,734867.78120891,60.8742179870605,30,1.78443339514941,-1.21384470101514 +-153.81522,56.62173,13.719616,11321.9401425194,734867.777457134,57.4697189331055,31,1.75943907313683,-1.30463121265459 +-153.75477,56.6216225,13.719616,15025.89477644,734867.776060645,90.7910919189453,31,1.95804323926742,-0.583244193995593 +-153.69432,56.6214848,13.719616,18729.8743011975,734867.777070352,82.1166305541992,31,1.91443112090143,-0.741655856038769 +-153.63387,56.6213169,13.719616,22433.8848479521,734867.780551451,85.0095977783203,31,1.9294679613243,-0.687037759681328 +-153.57342,56.6211187,13.719616,26137.9326193949,734867.775427515,109.647727966309,130,2.03999963699924,-0.285555164748764 +-153.51297,56.6208903,13.719616,29842.0236950643,734867.772948422,116.527450561523,130,2.0664282448735,-0.189558917473739 +-153.45253,56.6206318,13.719616,33545.5513898774,734867.779326877,115.55712890625,130,2.06279674297086,-0.202749568917996 +-153.39208,56.6203429,13.719616,37249.7475579117,734867.770762676,143.771392822266,130,2.1576724800984,0.141866188560681 +-153.33163,56.6200239,13.719616,40954.0053297344,734867.776366443,143.501129150391,130,2.15685531836517,0.138898023904391 +-153.27119,56.6196747,13.719616,44657.7182035301,734867.778408944,142.476135253906,130,2.15374212613046,0.127590021114426 +-153.21075,56.6192952,13.719616,48361.5051654886,734867.771509162,143.504287719727,130,2.15686487741285,0.138932745094019 +-153.1503,56.6188855,13.719616,52065.9849566549,734867.774842241,149.862899780273,130,2.17569413174792,0.207325971243228 +-153.08986,56.6184456,13.719616,55769.9382585286,734867.773480038,119.120582580566,130,2.07598680874434,-0.154839485209104 +-153.02942,56.6179755,13.719616,59473.9839237663,734867.774912973,88.3546829223633,31,1.94622957267068,-0.626154803031119 +-152.96899,56.6174752,13.719616,63177.5153569891,734867.76985045,80.7522583007812,31,1.9071546765617,-0.76808597878465 +-152.90855,56.6169447,13.719616,66881.7641339221,734867.776997807,80.556640625,31,1.90610134696406,-0.771911972533465 +-152.84812,56.6163839,13.719616,70585.5111280374,734867.765867761,78.5000686645508,31,1.89487003662579,-0.81270729741719 +-152.78768,56.615793,13.719616,74289.9875373725,734867.779734192,75.0245819091797,31,1.87520358390306,-0.884141467070623 +-152.72725,56.6151718,13.719616,77993.974438133,734867.774753182,75.7695159912109,31,1.87949451302457,-0.868555587748199 +-152.66682,56.6145205,13.719616,81698.0902629675,734867.784155595,89.447868347168,31,1.9515699952545,-0.606756863898301 +-152.6064,56.6138389,13.719616,85401.7288515103,734867.773082233,133.245025634766,130,2.12465100471777,0.0219227647107872 +-152.54598,56.6131271,13.719616,89105.5088389957,734867.764753793,149.696838378906,130,2.17521262807121,0.205577012454597 +-152.48555,56.6123852,13.719616,92810.0488195005,734867.78463527,153.061141967773,130,2.18486494921591,0.240636997898889 +-152.42514,56.611613,13.719616,96513.5172441978,734867.768846046,91.8513031005859,134,1.96308532205042,-0.564929910174024 +-152.36472,56.6108106,13.719616,100217.758163776,734867.770830003,68.3440551757812,31,1.83470074397131,-1.03125934236421 +-152.30431,56.6099781,13.719616,103921.551968552,734867.772495853,58.0884704589844,31,1.76408994111785,-1.28773793265766 +-152.2439,56.6091153,13.719616,107625.518063982,734867.766465195,50.8997650146484,31,1.70671577736471,-1.49613727162576 +-152.18349,56.6082224,13.719616,111329.661991739,734867.775450633,52.5412750244141,31,1.72050060764587,-1.44606683346231 +-152.12308,56.6072992,13.719616,115033.990472637,734867.777570614,63.1190605163574,31,1.80016052607592,-1.15671927252 +-152.06268,56.6063459,13.719616,118737.896282494,734867.777685897,75.7627182006836,31,1.87945554781122,-0.868697120524856 +-152.00228,56.6053624,13.719616,122441.998569501,734867.781859251,90.4305191040039,31,1.95631502385632,-0.589521565650512 +-151.94189,56.6043487,13.719616,126145.690728302,734867.771561063,153.400833129883,134,2.18582771830089,0.244134050017191 +-151.8815,56.6033048,13.719616,129849.591600387,734867.765149912,302.717926025391,134,2.48103813930278,1.31642256053915 +-134.3405,54.9614474,13.719616,1241049.98906542,734867.83322971,300,351,2.47712125471966,1.30219531774308 +-134.28521,54.9517272,13.719616,1244753.81912577,734867.780642487,221,251,2.34439227368511,0.820085774002676 +-134.22995,54.9419804,13.719616,1248457.53495479,734867.69590335,203,251,2.30749603791321,0.686068114444982 +-134.17471,54.932207,13.719616,1252161.75325703,734867.766274106,192,151,2.28330122870355,0.598185661509398 +-134.1195,54.922407,13.719616,1255865.86528395,734867.803045048,177,151,2.24797326636181,0.46986441867983 +-134.06432,54.9125804,13.719616,1259569.87500547,734867.804945432,165,151,2.21748394421391,0.359118498119706 +-134.00917,54.9027272,13.719616,1263273.7863861,734867.770711769,152,151,2.18184358794477,0.229662551379749 +-133.95405,54.8928476,13.719616,1266977.59676706,734867.720342538,140,151,2.14612803567824,0.0999334713141587 +-133.89895,54.8829414,13.719616,1270681.92940866,734867.822658265,143,151,2.15533603746506,0.133379562029274 +-133.84389,54.8730087,13.719616,1274385.55948505,734867.704924579,144,151,2.15836249209525,0.14437250908227 +-133.78885,54.8630495,13.719616,1278089.71636045,734867.749127528,142,151,2.15228834438306,0.122309470857218 +-133.73384,54.8530639,13.719616,1281793.78787826,734867.773310548,138,151,2.13987908640124,0.07723550391239 +-133.67886,54.8430519,13.719616,1285497.77791798,734867.776235559,128,151,2.10720996964787,-0.0414280528301153 +-133.62391,54.8330134,13.719616,1289201.69371516,734867.746061708,117,151,2.06818586174616,-0.183174751318448 +-133.56899,54.8229485,13.719616,1292905.53579457,734867.692180641,93.4549560546875,151,1.97060233760495,-0.537625964110132 +-133.51409,54.8128573,13.719616,1296609.91736446,734867.819219215,55.947265625,151,1.7477788656098,-1.34698441454734 +-133.45923,54.8027397,13.719616,1300313.62019649,734867.725435141,101,151,2.00432137378264,-0.415148800341636 +-133.40439,54.7925957,13.719616,1304017.87359078,734867.800663053,109,151,2.03742649794062,-0.294901540256673 +-133.34958,54.7824254,13.719616,1307722.06526556,734867.859061581,118,151,2.07188200730613,-0.169749295659684 +-133.29481,54.7722289,13.719616,1311425.58289886,734867.712553365,120,151,2.07918124604762,-0.143236377140402 +-133.24006,54.762006,13.719616,1315129.66256705,734867.733144091,158,151,2.19865708695442,0.290733978833201 +-133.18534,54.7517569,13.719616,1318833.688515,734867.74391678,170,151,2.23044892137827,0.406210995753595 +-133.13065,54.7414815,13.719616,1322537.6679556,734867.733101401,199,151,2.29885307640971,0.65467441131743 +-133.07599,54.7311799,13.719616,1326241.60123433,734867.710106722,178,151,2.25042000230889,0.478751662007618 +-133.02136,54.7208521,13.719616,1329945.4921136,734867.673759153,178,151,2.25042000230889,0.478751662007618 +-132.96675,54.7104982,13.719616,1333649.9536086,734867.834283249,177,151,2.24797326636181,0.46986441867983 +-132.91218,54.700118,13.719616,1337353.77094575,734867.768290508,163.742370605469,151,2.21416107366452,0.347048883842639 +-132.85764,54.6897117,10.34164922,1341057.55365517,734867.696031978,63.4271011352539,50,1.80227486290728,-1.14903939765666 +-132.80312,54.6792793,12.25413894,1344761.91817549,734867.818842109,96.8189697265625,50,1.98596045689969,-0.481840891187949 +-132.69418,54.6583361,10.90467251,1352169.96009415,734867.826785757,47.4188575744629,50,1.67595108665011,-1.60788340941816 +-157.79741,56.5289007,13.28513029,-233142.304983016,731163.781102505,26.529224395752,20,1.4237245532025,-2.52404217152 +-157.73721,56.5307833,13.719616,-229438.443159373,731163.788136548,105.26188659668,20,2.02227114956103,-0.34995009133844 +-157.677,56.5326359,13.719616,-225734.344816746,731163.788338255,99.5837936401367,20,1.99818866668332,-0.437424542975254 +-157.61678,56.5344583,13.719616,-222030.005147684,731163.760235177,122.764915466309,120,2.08907426911426,-0.10730209361246 +-157.55656,56.5362508,13.64703576,-218326.02955849,731163.77093465,56.7187271118164,20,1.75372647579777,-1.32538099672769 +-157.49634,56.5380131,13.719616,-214622.413815727,731163.786178727,50.5750999450684,20,1.70393674968404,-1.50623149337542 +-157.4361,56.5397454,13.719616,-210917.924115639,731163.763898747,83.2928466796875,20,1.92060770511703,-0.719220739195062 +-157.37587,56.5414476,13.719616,-207214.394842154,731163.789092966,112.450759887695,20,2.05096239453304,-0.245735300303493 +-156.95405,56.5525203,13.34768093,-181286.021434612,731163.762284009,39.635871887207,20,1.59808841599575,-1.89070285345361 +-156.89377,56.5539818,13.719616,-177581.984193914,731163.770260524,42.142650604248,20,1.62472184751785,-1.79396262822715 +-156.83349,56.5554131,13.719616,-173878.240014341,731163.78113009,119.096832275391,20,2.07590021031894,-0.155154035407834 +-156.7732,56.5568143,13.719616,-170174.16904773,731163.779738883,118.188835144043,121,2.07257645231214,-0.167226873183495 +-156.71291,56.5581853,13.719616,-166470.378959543,731163.78102104,131.923416137695,121,2.12032188877459,0.00619817995244383 +-156.65261,56.5595263,13.719616,-162766.249474151,731163.782113786,154.275466918945,121,2.18829686949261,0.253102711911435 +-156.59231,56.5608371,13.719616,-159062.38870026,731163.785717576,175.761657714844,121,2.24492414002655,0.458789121522886 +-156.532,56.5621178,13.719616,-155358.176825786,731163.778967725,186.937088012695,121,2.27169547324261,0.556030245062848 +-156.47169,56.5633683,13.719616,-151654.221471398,731163.774622259,201.008193969727,220,2.30321376151653,0.670513664288857 +-156.41138,56.5645887,13.719616,-147950.516124761,731163.783239068,206.727523803711,220,2.31539830265677,0.714771395524501 +-156.35106,56.565779,13.719616,-144246.441426313,731163.782522999,206.190521240234,220,2.31426869650675,0.710668343565944 +-156.29073,56.5669392,13.719616,-140541.991297098,731163.773586527,219.410278320312,220,2.34125696833094,0.808697450051084 +-156.23041,56.5680691,13.719616,-136838.386969518,731163.776467299,244.096984863281,220,2.38756241495456,0.976892049078408 +-156.17008,56.569169,13.719616,-133134.394645478,731163.782312169,270.910278320312,220,2.43282548245331,1.14130042959953 +-156.10974,56.5702387,13.719616,-129430.008982302,731163.769977301,287.021118164062,220,2.45791385201171,1.23242854876927 +-156.04941,56.5712782,13.719616,-125726.450430153,731163.778493777,283.254638671875,220,2.4521770307441,1.21159077647347 +-155.98907,56.5722876,13.719616,-122022.485978,731163.780100422,272.752563476562,220,2.43576884101471,1.15199154801273 +-155.92872,56.5732669,13.719616,-118318.109541583,731163.775994627,260.770446777344,220,2.41625837107529,1.08112395235021 +-155.86837,56.574216,13.719616,-114613.928631219,731163.773495143,249.908538818359,220,2.39778109525547,1.01400921263303 +-155.80802,56.5751349,13.719616,-110909.937130679,731163.772153619,238.447219848633,220,2.37739226318659,0.939951155006813 +-155.74767,56.5760236,13.719616,-107206.128922979,731163.771535902,227.378494262695,220,2.35674938618851,0.864970333686084 +-155.68732,56.5768822,13.719616,-103502.497607004,731163.782374129,214.966857910156,220,2.33237150858435,0.776422924088762 +-155.62696,56.5777106,13.719616,-99798.4240864417,731163.778083782,195.171844482422,220,2.2904171664666,0.62403277855563 +-155.5666,56.5785089,13.719616,-96094.5152606322,731163.78556879,160.318359375,121,2.20498325983816,0.313712444416449 +-155.50623,56.579277,13.719616,-92390.1520116575,731163.779387999,108.733665466309,121,2.03636402856306,-0.29876073229495 +-155.44586,56.5800149,13.719616,-88685.9415007028,731163.77420579,83.9615173339844,121,1.92408027845517,-0.706607361659808 +-155.3855,56.5807226,13.719616,-84982.490888342,731163.782469783,76.1066360473633,22,1.88142252632512,-0.8615524931308 +-155.32512,56.5814001,13.719616,-81277.954208293,731163.765456289,68.9953460693359,22,1.83881979733766,-1.01629776484275 +-155.26475,56.5820475,13.719616,-77574.1649706897,731163.772387901,58.8184700012207,22,1.76951372335586,-1.2680372074676 +-155.20438,56.5826647,13.719616,-73870.5040040102,731163.779008967,48.9582977294922,22,1.68982630906519,-1.55748464122383 +-155.144,56.5832517,13.719616,-70166.3519035088,731163.774462261,41.1393623352051,22,1.61425755579701,-1.83197192256345 +-155.08362,56.5838086,13.719616,-66462.3156450663,731163.78130542,35.7879409790039,22,1.55373671243917,-2.05180090000763 +-155.02324,56.5843352,13.719616,-62758.3894787317,731163.776966938,30.0789928436279,22,1.47826329037115,-2.32594191121807 +-154.96285,56.5848317,13.719616,-59053.9536444815,731163.774614174,27.2371520996094,22,1.43516169604239,-2.48249920423995 +-154.90247,56.585298,13.719616,-55350.2287624896,731163.781200344,27.4799308776855,22,1.43901563597567,-2.4685005943783 +-154.84208,56.585734,13.719616,-51645.9822857027,731163.768123471,27,22,1.43136376415899,-2.49629437687814 +-154.7817,56.5861399,13.719616,-47942.4343584833,731163.773598065,26,22,1.41497334797082,-2.55582904676412 +-154.72131,56.5865157,13.719616,-44238.3523220533,731163.78243682,22,22,1.34242268082221,-2.81935377786993 +-154.66092,56.5868612,13.719616,-40534.3435840659,731163.779928795,17,22,1.23044892137827,-3.22607443266317 +-154.60053,56.5871765,13.20722795,-36830.4018865326,731163.777065547,11,22,1.04139268515823,-3.91278064463658 +-154.35895,56.5881359,13.67872326,-22013.9562748257,731163.774973724,15.9540176391602,22,1.2028700678823,-3.32624870034905 +-154.05698,56.5886558,12.07801548,-3494.47923076106,731163.780249374,13,22,1.11394335230684,-3.64925591353076 +-153.99658,56.5886692,13.719616,209.742296311393,731163.781406988,31.1946754455566,30,1.49408047151993,-2.26848939461271 +-153.93618,56.5886523,13.719616,3913.96417907359,731163.771314187,32.9206733703613,30,1.51746870983432,-2.18353663738702 +-153.87579,56.5886053,13.71932242,7617.57925293407,731163.771143349,47.3974380493164,30,1.67575486759993,-1.6085961330149 +-153.81539,56.5885281,13.719616,11321.8202098488,731163.771497329,55.9533233642578,31,1.74782588668018,-1.34681362059858 +-153.75499,56.5884207,13.719616,15026.0798964498,731163.771823346,80.0681381225586,31,1.90345972968738,-0.781507080474999 +-153.6946,56.5882832,13.719616,18729.7511079827,731163.78050751,106.100028991699,31,2.02571550257178,-0.337439218087194 +-153.6342,56.5881154,13.719616,22434.0666280678,731163.780386445,109.94287109375,31,2.04116707412409,-0.281314699891602 +-153.57381,56.5879174,13.719616,26137.8059803099,731163.776496848,123.771240234375,130,2.0926197427574,-0.0944239213616723 +-153.51342,56.5876892,13.719616,29841.5885740301,731163.771752664,122.372535705566,130,2.08768395923203,-0.112352095938677 +-153.45302,56.5874309,13.719616,33546.0337264937,731163.782468398,125.608734130859,130,2.09901983886738,-0.0711769455209149 +-153.39263,56.5871423,13.719616,37249.9211755639,731163.776910706,100.624794006348,130,2.00270500431259,-0.421019915614646 +-153.33224,56.5868236,13.719616,40953.8701360634,731163.782020175,102.249824523926,130,2.00966257136538,-0.395748046191553 +-153.27185,56.5864746,13.719616,44657.8869491046,731163.775637112,100.42845916748,130,2.00185679954213,-0.424100837442705 +-153.21146,56.5860955,13.719616,48361.9775068519,731163.780236751,123.747871398926,130,2.09253773732156,-0.0947217885113286 +-153.15108,56.5856862,13.719616,52065.5347662561,731163.77700328,107.234619140625,130,2.03033501366441,-0.320659835259027 +-153.09069,56.5852467,13.719616,55769.7914164925,731163.781252338,92.2144012451172,31,1.96479875069445,-0.558706248277673 +-153.03031,56.584777,13.719616,59473.5270201145,731163.776954192,89.0088882446289,31,1.94943337656467,-0.61451767283147 +-152.96992,56.5842771,13.719616,63177.9742655777,731163.781683969,87.8899688720703,31,1.94393931065847,-0.634473688365323 +-152.90954,56.583747,13.719616,66881.9127146861,731163.777209496,86.3323669433594,31,1.93617364796952,-0.662680791792386 +-152.84916,56.5831868,13.719616,70585.9615802098,731163.783890803,79.5477828979492,31,1.90062807978895,-0.791792441139451 +-152.78879,56.5825963,13.719616,74289.5140811356,731163.768498225,78.535285949707,31,1.89506482935772,-0.811999754615443 +-152.72841,56.5819757,13.719616,77993.8025074568,731163.775433666,80.3819961547852,31,1.90515878697973,-0.77533561942998 +-152.66804,56.5813249,13.719616,81697.6066124627,731163.770906089,81.6926803588867,31,1.91218314561254,-0.749821143924053 +-152.60767,56.5806439,13.719616,85401.5458003347,731163.766409448,131.326599121094,130,2.11835269776937,-0.000954483841584437 +-152.5473,56.5799328,13.719616,89105.6259491434,731163.773418615,138.812911987305,130,2.14242986485102,0.0865006593066535 +-152.48693,56.5791915,13.719616,92809.8534041244,731163.781116301,159.792678833008,134,2.20355687751075,0.30853141667323 +-152.42657,56.57842,13.719616,96513.6210046344,731163.775320063,143.082412719727,134,2.15558625480674,0.134288422833392 +-152.36621,56.5776183,13.719616,100217.548152557,731163.769811843,104.583419799805,134,2.01946283883138,-0.360150677480209 +-152.30585,56.5767865,13.719616,103921.640683022,731163.776122423,80.094482421875,31,1.90360259927689,-0.780988137346863 +-152.24549,56.5759245,13.719616,107625.904979326,731163.783492411,70.9811248779297,31,1.85114287757577,-0.971536820060651 +-152.18514,56.5750323,13.719616,111329.733878243,731163.775565334,74.1622009277344,31,1.8701826099793,-0.902379077490355 +-152.12479,56.57411,13.719616,115033.746464016,731163.779562129,89.1803207397461,31,1.95026902996976,-0.611482341144944 +-152.06444,56.5731575,13.719616,118737.949148231,731163.784766829,104.148284912109,31,2.01765212248981,-0.36672771606269 +-152.0041,56.5721748,13.719616,122441.73476546,731163.773192415,139.138381958008,134,2.14344694863501,0.090194997914721 +-151.94376,56.571162,13.719616,126145.722367289,731163.773774753,216.358947753906,134,2.33517486061536,0.786605498821728 +-151.88342,56.570119,13.719616,129849.91839336,731163.775841377,358.420379638672,134,2.55439269550177,1.58286724612871 +-134.30211,54.9199059,13.71338168,1244753.55101511,731163.703214276,448,351,2.65127801399814,1.9347823767306 +-134.24688,54.9101667,13.719616,1248457.982034,731163.833027072,215,251,2.33243845991561,0.776666110433694 +-134.19169,54.9004009,13.719616,1252161.68578258,731163.739148469,204,151,2.3096301674259,0.693819881976265 +-134.13652,54.8906086,13.719616,1255865.88951956,731163.807467019,194,151,2.28780172993023,0.614532766535627 +-134.08138,54.8807897,13.719616,1259569.98719546,731163.838073965,160,151,2.20411998265592,0.310576775286727 +-134.02627,54.8709442,13.719616,1263273.9827748,731163.82969938,181,151,2.25767857486918,0.505116869349467 +-133.97119,54.8610723,13.719616,1266977.87360466,731163.802335917,150,151,2.17609125905568,0.208768450976442 +-133.91614,54.8511738,13.719616,1270681.67021578,731163.733461124,139,151,2.14301480025409,0.0886253116478125 +-133.86111,54.8412489,13.719616,1274385.98319095,731163.834964032,135,151,2.13033376849501,0.0425641847719837 +-133.80612,54.8312975,13.719616,1278089.59318974,731163.711737506,147,151,2.16731733474818,0.176899053564259 +-133.75115,54.8213197,13.719616,1281793.72734552,731163.757499707,152,151,2.18184358794477,0.229662551379749 +-133.69621,54.8113154,13.719616,1285497.77960612,731163.768499387,164,151,2.2148438480477,0.349528915285568 +-133.6413,54.8012848,13.719616,1289201.74715501,731163.764728159,150,151,2.17609125905568,0.208768450976442 +-133.58642,54.7912277,13.719616,1292905.64056929,731163.72373223,127,151,2.10380372095596,-0.0538005203193092 +-133.47674,54.7710346,13.719616,1300313.8135208,731163.784620049,118.374465942383,151,2.07325803265505,-0.164751178835646 +-133.42195,54.7608985,13.719616,1304017.4908282,731163.67822137,138,151,2.13987908640124,0.07723550391239 +-133.36718,54.7507361,13.719616,1307721.7159173,731163.747855234,134,151,2.12710479836481,0.0308356436192711 +-133.31244,54.7405475,13.719616,1311425.87591156,731163.80711142,134,151,2.12710479836481,0.0308356436192711 +-133.25773,54.7303325,13.719616,1315129.98143394,731163.833604075,116,151,2.06445798922692,-0.19671544834909 +-133.20305,54.7200913,13.719616,1318834.02945934,731163.847323766,142,151,2.15228834438306,0.122309470857218 +-133.1484,54.7098239,13.719616,1322538.02376122,731163.847077008,177,151,2.24797326636181,0.46986441867983 +-133.09378,54.6995303,13.719616,1326241.96810767,731163.831677038,156,151,2.19312459835446,0.27063840110868 +-133.03919,54.6892105,13.719616,1329945.86626135,731163.799943775,182,151,2.26007138798507,0.513808249563239 +-132.98463,54.6788645,13.719616,1333649.7219795,731163.750703784,176,251,2.24551266781415,0.460926822429992 +-132.9301,54.6684924,13.719616,1337353.53554273,731163.693361706,187,251,2.2718416065365,0.556561042896859 +-132.87559,54.6580941,13.719616,1341057.92743296,731163.818112774,156.644866943359,151,2.19491616816315,0.277145894018773 +-132.82112,54.6476697,13.719616,1344761.67133957,731163.731060659,130.595794677734,151,2.11592919242405,-0.00975734699306465 +-132.76667,54.6372193,13.719616,1348465.99403834,731163.846035109,113.086074829102,151,2.05340913014905,-0.236848058178251 +-132.71226,54.6267427,13.719616,1352169.67965588,731163.735219699,108.647232055664,50,2.03601866652158,-0.300015185805735 +-158.09461,56.4858942,12.54186208,-251662.227292715,727459.77847405,100.215286254883,20,2.00093397132965,-0.427452812911832 +-158.03449,56.4879253,13.3698031,-247957.967784813,727459.766192382,45.0993537902832,20,1.65417031909914,-1.68699737401328 +-157.97437,56.4899263,8.655449182,-244254.115284313,727459.768679768,15.9637241363525,20,1.20313421428268,-3.32528924522797 +-157.79397,56.4957494,13.51599717,-233142.479588963,727459.792973243,63.3782081604004,20,1.80193995657957,-1.15025587303068 +-157.67366,56.4994813,13.63220535,-225733.984902583,727459.763466552,37.7511329650879,20,1.57692998995467,-1.96755629605085 +-157.6135,56.5013022,13.719616,-222029.989281521,727459.763454779,113.198211669922,120,2.05383956582734,-0.235284592936124 +-157.55334,56.5030931,13.719616,-218326.357849361,727459.787542882,136.319763183594,120,2.13455882296145,0.0579107885447032 +-157.49317,56.5048539,13.719616,-214622.471331457,727459.791435389,137.394515991211,120,2.13796939850019,0.0702989723766086 +-157.43299,56.5065847,13.719616,-210918.32309797,727459.787118553,107.068809509277,120,2.02966297381172,-0.323100875823254 +-157.3728,56.5082854,13.719616,-207213.907690575,727459.764314192,107.505470275879,20,2.03143056332311,-0.316680486197593 +-157.31262,56.509956,13.70072609,-203510.446731641,727459.785184812,37.4642448425293,20,1.57361698305643,-1.97959008273159 +-157.25242,56.5115966,13.65518471,-199806.092099582,727459.76815502,34.0654029846191,20,1.53231353089353,-2.12961601016617 +-157.19222,56.5132071,13.45098877,-196102.065980372,727459.763717329,21.9731101989746,20,1.34189153378223,-2.8212830555236 +-157.13202,56.5147876,13.56133305,-192398.361787924,727459.782257434,24.7071857452393,20,1.3928232802091,-2.63628441513343 +-157.07181,56.516338,13.719616,-188694.360167519,727459.783478236,40.5741920471191,20,1.60824988048912,-1.85379351404298 +-157.01159,56.5178583,13.61584493,-184990.055056426,727459.768324319,26.4711742401123,20,1.42277320668443,-2.52749773361495 +-156.95137,56.5193485,13.70438589,-181286.054229987,727459.765051938,43.670482635498,20,1.64018799166431,-1.73778517821019 +-156.89115,56.5208087,13.719616,-177582.351137572,727459.784104885,64.8158111572266,20,1.8116809605116,-1.11487376639022 +-156.83092,56.5222387,13.719616,-173878.326854557,727459.776326446,108.332321166992,20,2.03475804859481,-0.304594109931943 +-156.77068,56.5236387,13.719616,-170173.97435262,727459.765006526,122.508720397949,121,2.08816700368762,-0.110597540601375 +-156.71045,56.5250086,13.719616,-166470.515727204,727459.790148969,149.584823608398,121,2.17488753365232,0.204396176733987 +-156.6502,56.5263484,13.719616,-162766.103390643,727459.775909608,166.546676635742,121,2.221535970962,0.373836615832352 +-156.58995,56.527658,13.719616,-159061.959385644,727459.761760579,178.542556762695,121,2.25174174966031,0.483552625652219 +-156.5297,56.5289376,13.719616,-155358.076760369,727459.769378344,196.936630249023,121,2.29432650250407,0.63823260287932 +-156.46945,56.5301871,13.719616,-151654.449886921,727459.787014896,206.075088500977,121,2.31402549502782,0.709784966377853 +-156.40919,56.5314064,13.719616,-147950.459256635,727459.780656721,209.266082763672,220,2.32069884485939,0.734024477729768 +-156.34892,56.5325957,13.719616,-144246.097975309,727459.77369823,212.334945678711,220,2.32702147540238,0.756990076520362 +-156.28865,56.5337548,13.719616,-140541.974605401,727459.766119784,228.067962646484,220,2.35806428298359,0.869746414154739 +-156.22838,56.5348838,13.719616,-136838.082665494,727459.76852351,253.535507202148,220,2.40403879010761,1.03673894645994 +-156.16811,56.5359827,13.719616,-133134.416077839,727459.780378043,279.555480957031,220,2.44646801144377,1.19085398885834 +-156.10783,56.5370515,13.719616,-129430.354924481,727459.781676842,281.690032958984,220,2.449771480612,1.20285313178132 +-156.04755,56.5380901,13.719616,-125726.507309089,727459.781371721,274.310333251953,220,2.43824216775683,1.16097537669785 +-155.98726,56.5390986,13.719616,-122022.252947882,727459.771749032,263.242309570312,220,2.42035569245026,1.09600659307604 +-155.92697,56.540077,13.719616,-118318.199598989,727459.771823204,251.549652099609,220,2.40062372102045,1.0243344407776 +-155.86668,56.5410253,13.719616,-114614.341180427,727459.781133547,238.750473022461,220,2.3779442406991,0.9419560948823 +-155.80638,56.5419434,13.719616,-110910.058073529,727459.7713819,226.341094970703,220,2.35476341254383,0.857756710555289 +-155.74608,56.5428314,13.719616,-107205.957710471,727459.771102366,213.748580932617,220,2.32990324014791,0.767457468613653 +-155.68578,56.5436892,13.719616,-103502.034290162,727459.768725132,192.830749511719,220,2.28517628930974,0.604996416826676 +-155.62548,56.5445169,13.719616,-99798.281424295,727459.774997185,157.228652954102,121,2.19653169364946,0.283013943701933 +-155.56517,56.5453145,13.719616,-96094.07918796,727459.775059022,108.827110290527,121,2.03673709741129,-0.297405639753715 +-155.50486,56.5460819,13.719616,-92390.0355869647,727459.772967684,79.0839538574219,22,1.8980883740399,-0.801017377324192 +-155.44455,56.5468192,13.719616,-88686.1442614196,727459.779513466,72.9999389648438,22,1.86332249700754,-0.927296965874962 +-155.38424,56.5475263,13.719616,-84982.3993563349,727459.783196226,65.9198303222656,22,1.8190160808159,-1.08823051579323 +-155.32392,56.5482032,13.719616,-81278.1809139513,727459.771443443,61.205005645752,22,1.78678694233231,-1.20529594587761 +-155.2636,56.54885,13.719616,-77574.0964423282,727459.768442884,51.550853729248,22,1.7122358619926,-1.47608674866827 +-155.20328,56.5494667,13.719616,-73870.1398523097,727459.77388977,47.6565551757812,22,1.67812264644058,-1.59999568443429 +-155.14296,56.5500532,13.719616,-70166.3052462096,727459.776339875,39.2995491027832,22,1.59438756759434,-1.90414539117482 +-155.08263,56.5506096,13.719616,-66461.9724823398,727459.776662346,33.5178298950195,22,1.52527589256184,-2.15517872132886 +-155.02231,56.5511357,13.719616,-62758.3634921375,727459.77286018,30.3418674468994,22,1.48204230673829,-2.31221544513393 +-154.96198,56.5516318,13.719616,-59054.2439604133,727459.778689075,27.7557392120361,22,1.4433527982841,-2.45274678292471 +-154.90165,56.5520977,13.719616,-55350.2219683148,727459.781614895,24.1150989532471,22,1.38228904833383,-2.67454775207356 +-154.84132,56.5525334,13.719616,-51646.2913936117,727459.781417589,23,22,1.36172783601759,-2.74923194396041 +-154.78099,56.5529389,13.719616,-47942.4461137053,727459.777891388,21,22,1.32221929473392,-2.8927382427631 +-154.72065,56.5533143,13.719616,-44238.0660452999,727459.775338081,19,22,1.27875360095283,-3.05061804892018 +-154.35863,56.5549331,9.1091002,-22014.3330654904,727459.774147874,11,22,1.04139268515823,-3.91278064463658 +-153.81556,56.555325,13.719616,11321.6812936848,727459.77286786,52.1056365966797,31,1.71688470622515,-1.45920081950338 +-153.75522,56.5552177,13.719616,15025.6266096705,727459.772636124,65.683967590332,31,1.81745937813308,-1.0938849042644 +-153.69488,56.5550803,13.719616,18729.5966992078,727459.780078808,80.3079681396484,31,1.90475863802337,-0.776789074653345 +-153.63454,56.5549126,13.719616,22433.5977795512,727459.772950426,109.416664123535,130,2.03908346994771,-0.288882944980052 +-153.5742,56.5547148,13.719616,26137.6358628213,727459.773640491,145.087860107422,130,2.16163107536727,0.156244936472793 +-153.51386,56.5544868,13.719616,29841.7171248821,727459.771087274,129.767532348633,130,2.11316604619588,-0.0197938827742324 +-153.45352,56.5542287,13.719616,33545.8475983845,727459.776553406,121.953910827637,130,2.08619573186278,-0.117757762526179 +-153.39318,56.5539404,13.719616,37250.0334790977,727459.779005728,92.1169357299805,31,1.96433948272582,-0.560374440627897 +-153.33285,56.5536219,13.719616,40953.6670517413,727459.772413702,90.3440933227539,31,1.95589976374598,-0.591029908898272 +-153.27251,56.5532733,13.719616,44657.9819965121,727459.779858116,97.1598510742188,31,1.98748684045077,-0.476296630457197 +-153.21218,56.5528945,13.719616,48361.7568602394,727459.777457604,100.723495483398,31,2.00313078901015,-0.419473344062054 +-153.15185,56.5524855,13.719616,52065.6116054425,727459.771557829,99.4730453491211,31,1.99770541399152,-0.439179854685909 +-153.09152,56.5520464,13.719616,55769.5522024306,727459.773506202,93.1868286132812,31,1.96935453183023,-0.542158350843144 +-153.03119,56.5515771,13.719616,59473.5849060891,727459.772355604,92.9973220825195,31,1.96847044294609,-0.545369614014414 +-152.97086,56.5510777,13.719616,63177.7156657544,727459.779481598,92.1208953857422,31,1.96435815051665,-0.560306633883257 +-152.91053,56.5505481,13.719616,66881.9507558191,727459.783965845,83.4021377563477,31,1.92117718257883,-0.717152234508752 +-152.85021,56.5499883,13.719616,70585.6824583656,727459.775429799,73.1529006958008,31,1.86423155166712,-0.923995019881356 +-152.78989,56.5493984,13.719616,74289.5305303926,727459.77480438,73.3065185546875,31,1.86514259464739,-0.920685851739435 +-152.72957,56.5487783,13.719616,77993.5012753793,727459.771214364,78.8657150268555,31,1.89688824515282,-0.805376587992963 +-152.66925,56.5481281,13.719616,81697.6005898041,727459.77610555,87.5511245727539,31,1.94226172886155,-0.640567144281228 +-152.60893,56.5474477,13.719616,85401.8347964095,727459.778631553,141.270370483398,130,2.15005108410685,0.11418310295638 +-152.54862,56.5467372,13.719616,89105.5959310618,727459.776848865,181.418502807617,134,2.25868157852042,0.508760064896494 +-152.48831,56.5459965,13.719616,92809.5041749701,727459.772241751,245.034591674805,134,2.38922739829529,0.982939743805495 +-152.428,56.5452256,13.719616,96513.5656459415,727459.765159891,266.466094970703,134,2.42564195743809,1.1152078163621 +-152.36769,56.5444247,13.719616,100217.785912855,727459.778270802,256.066253662109,134,2.40835234764447,1.0524070186457 +-152.30739,56.5435936,13.719616,103921.557760771,727459.773999666,187.722183227539,134,2.27351559645756,0.562641452094459 +-152.24709,56.5427323,13.719616,107625.501144898,727459.767271534,98.1932907104492,31,1.99208181459985,-0.459606372811552 +-152.18679,56.5418409,13.719616,111329.621875927,727459.769643888,112.612373352051,31,2.05158611150369,-0.243469782239543 +-152.12649,56.5409194,13.719616,115033.926038003,727459.781536577,134.756423950195,134,2.12954947752945,0.0397154161261397 +-152.0662,56.5399677,13.719616,118737.806200007,727459.774353956,189.45979309082,134,2.27751705867611,0.577175905003231 +-152.00591,56.5389859,13.719616,122441.881979386,727459.776458902,232.363433837891,134,2.36616778580139,0.899180649358941 +-151.94563,56.537974,13.719616,126145.545618717,727459.76931903,315.064575195312,134,2.49839957530325,1.37948425154003 +-151.88534,56.5369319,13.719616,129850.031232841,727459.779692997,517.977966308594,330,2.71431128616586,2.16373721273082 +-134.26379,54.878349,13.719616,1248457.93007599,727459.818331446,224,251,2.35024801833416,0.841355509963957 +-134.20864,54.8685909,13.719616,1252161.72507852,727459.759410867,218,251,2.3384564936046,0.798525326509967 +-134.15351,54.8588062,13.719616,1255866.02015253,727459.849215535,196,151,2.29225607135648,0.630712205991387 +-134.09842,54.8489949,13.719616,1259569.59158935,727459.708809685,193,151,2.28555730900777,0.60638038912377 +-134.04335,54.8391572,13.719616,1263273.66444339,727459.736946396,191,251,2.28103336724773,0.589948141389748 +-133.98831,54.8292929,13.719616,1266977.63538818,727459.721978202,189,151,2.27646180417324,0.573342919449214 +-133.9333,54.8194022,13.719616,1270681.50175373,727459.6838934,181,151,2.25767857486918,0.505116869349467 +-133.87831,54.809485,13.719616,1274385.88459584,727459.802691174,152,151,2.18184358794477,0.229662551379749 +-133.82336,54.7995414,13.719616,1278089.55682326,727459.704504949,144,151,2.15836249209525,0.14437250908227 +-133.76843,54.7895713,13.719616,1281793.75333785,727459.761805268,173,151,2.2380461031288,0.433806128323048 +-133.71353,54.7795748,13.719616,1285497.86085942,727459.792069763,180,151,2.25527250510331,0.496377337199112 +-133.65866,54.769552,13.719616,1289201.87990678,727459.804664976,183,151,2.26245108973043,0.522452005536869 +-133.60382,54.7595028,13.719616,1292905.81768703,727459.787737531,176,151,2.24551266781415,0.460926822429992 +-133.54901,54.7494272,13.719616,1296609.67806378,727459.740057395,122,151,2.08635983067475,-0.117161708802643 +-133.49422,54.7393253,13.719616,1300314.07535286,727459.866800981,98.8144302368164,151,1.99482037084881,-0.449659154853531 +-133.43947,54.7291971,13.719616,1304017.78570235,727459.775705376,180,151,2.25527250510331,0.496377337199112 +-133.38474,54.7190426,13.719616,1307722.04061219,727459.857705749,206,151,2.31386722036915,0.709210067641479 +-133.33005,54.7088618,13.719616,1311425.61621967,727459.718321941,210,251,2.32221929473392,0.739547185653671 +-133.27538,54.6986548,13.719616,1315129.74059756,727459.761323531,205,251,2.31175386105575,0.70153374340241 +-133.22074,54.6884215,13.719616,1318833.80711067,727459.778003708,216,251,2.33445375115093,0.783986223421782 +-133.16613,54.678162,13.719616,1322537.81612503,727459.777755337,187,151,2.2718416065365,0.556561042896859 +-133.11155,54.6678764,13.719616,1326241.76796665,727459.769966018,209,151,2.32014628611105,0.732017426639857 +-133.057,54.6575645,13.719616,1329945.6732744,727459.732284487,287,251,2.45788189673399,1.23231247807964 +-133.00248,54.6472265,13.719616,1333649.52891255,727459.684689527,328,251,2.51587384371168,1.44295578205221 +-132.94798,54.6368624,13.719616,1337353.95244664,727459.827373988,339.486297607422,251,2.53082224991673,1.49725266008887 +-132.89352,54.6264722,13.719616,1341057.71991886,727459.756969538,325.052459716797,350,2.51195345675418,1.42871581763273 +-132.83908,54.6160558,13.719616,1344762.06620866,727459.865049266,201,251,2.30319605742049,0.670449357958785 +-132.78468,54.6056134,13.719616,1348465.76038524,727459.767161536,163,151,2.21218760440396,0.339880680204086 +-132.7303,54.5951449,13.719616,1352170.03730861,727459.857120438,188,151,2.27415784926368,0.564974297603475 +-132.67596,54.5846504,9.204863995,1355873.66948816,727459.737678405,237,251,2.3747483460101,0.930347693172715 +-158.39111,56.4421539,12.16122692,-270182.349618352,723755.788028565,13.7748680114746,20,1.13908744620528,-3.55792538765269 +-158.33108,56.444333,13.719616,-266478.174465603,723755.770014173,34.5853309631348,20,1.53889193600069,-2.10572136515324 +-158.27105,56.4464822,13.53216905,-262774.434344168,723755.786981576,56.3622016906738,20,1.75098794972182,-1.33532810508869 +-158.21101,56.4486015,12.17928366,-259070.508887102,723755.798918875,40.9506416320801,20,1.61226071086051,-1.83922503332912 +-158.15096,56.4506907,11.73808994,-255366.393516264,723755.784246922,66.1291885375977,20,1.82039319356734,-1.08322844921288 +-158.0909,56.45275,13.69633357,-251662.08082473,723755.765926479,94.2764282226562,20,1.9744031203884,-0.523820436189226 +-158.03084,56.4547793,13.719616,-247958.17991125,723755.770873811,55.1957855224609,20,1.74190591841371,-1.36831663506955 +-157.97077,56.4567787,13.70203665,-244254.069705573,723755.772495413,46.8257904052734,20,1.67048511686952,-1.62773737180437 +-157.9107,56.458748,13.46817829,-240550.359939554,723755.785483709,39.9814109802246,20,1.60185811669837,-1.87701022452198 +-157.85062,56.4606873,13.13547229,-236846.429529701,723755.784387793,38.7826805114746,20,1.58863782256401,-1.9250301062656 +-157.79053,56.4625967,13.719616,-233142.271828308,723755.781109979,85.5469207763672,20,1.93220438192037,-0.677098299024206 +-157.73044,56.464476,13.67637754,-229438.496502148,723755.788707434,91.8746948242188,20,1.96319590951943,-0.564528224921777 +-157.67034,56.4663254,13.719616,-225734.481877221,723755.794583095,83.7692947387695,20,1.92308485909347,-0.710223008902493 +-157.61023,56.4681447,13.719616,-222030.223179973,723755.777271336,93.6166610717773,120,1.9713531475374,-0.534898808132971 +-157.55012,56.469934,13.719616,-218326.328163848,723755.781605685,122.269256591797,120,2.08731727166447,-0.11368400984711 +-157.49,56.4716933,13.719616,-214622.176413001,723755.774431546,155.691833496094,120,2.19226583311662,0.267519120648852 +-157.42988,56.4734226,13.719616,-210918.376304256,723755.788358235,173.966644287109,120,2.24046598626694,0.442595834584205 +-157.36975,56.4751218,13.719616,-207214.307984702,723755.780234603,151.861206054688,120,2.18144684464512,0.22822146647361 +-157.30961,56.476791,13.719616,-203509.96484547,723755.762077188,117.158660888672,120,2.0687743990971,-0.18103701567456 +-157.24947,56.4784302,13.719616,-199805.955259305,723755.764863926,42.9944114685059,120,1.63341200846048,-1.76239748326463 +-157.18933,56.4800393,13.719616,-196102.273736059,723755.776685709,44.9480857849121,120,1.65271120105809,-1.69229730721214 +-157.12918,56.4816184,13.719616,-192398.299296126,723755.778958572,30.8067493438721,20,1.48864587499665,-2.28822940037355 +-157.06902,56.4831675,13.719616,-188694.025911333,723755.772616063,45.6579437255859,20,1.6595163484871,-1.6675790693675 +-157.00886,56.4846864,13.719616,-184990.062959694,723755.764175109,52.1017608642578,20,1.71685240124017,-1.4593181604296 +-156.9487,56.4861754,13.719616,-181286.402864701,723755.786351452,51.6416015625,20,1.71299970259071,-1.4733122615941 +-156.88853,56.4876343,13.719616,-177582.426197764,723755.78942115,77.7809753417969,20,1.89087338472176,-0.827224277890669 +-156.82835,56.4890631,13.719616,-173878.126895586,723755.774372319,95.6750030517578,20,1.98079848474928,-0.50059064741177 +-156.76817,56.4904618,13.719616,-170174.113290756,723755.767831535,133.067749023438,121,2.12407281040816,0.0198225979451887 +-156.70799,56.4918305,13.719616,-166470.378862975,723755.780287032,168.846572875977,121,2.2274922500697,0.395471521642845 +-156.6478,56.4931691,13.719616,-162766.303623422,723755.775442613,171.366470336914,121,2.23392585158866,0.418840198692419 +-156.58761,56.4944777,13.719616,-159062.495466856,723755.789439848,177.485443115234,121,2.24916273917153,0.474184923434081 +-156.52741,56.4957561,13.719616,-155358.334806523,723755.775978727,194.04704284668,121,2.28790702875521,0.614915241923263 +-156.46721,56.4970045,13.719616,-151654.429110687,723755.781259981,213.265640258789,121,2.32892089085486,0.763889295590882 +-156.407,56.4982228,13.719616,-147950.15834594,723755.771272866,215.979858398438,121,2.33441325210334,0.783839119321357 +-156.34679,56.499411,13.719616,-144246.13083746,723755.768838236,218.623397827148,121,2.33969663978861,0.803029891423221 +-156.28658,56.5005692,13.719616,-140542.340128439,723755.784545569,240.191955566406,220,2.38055845805597,0.951451678494367 +-156.22636,56.5016972,13.719616,-136838.166526148,723755.774950067,264.473693847656,220,2.42238248096491,1.10336846746429 +-156.16614,56.5027951,13.719616,-133134.217958856,723755.772389243,277.963623046875,220,2.44398796374641,1.18184574774544 +-156.10592,56.503863,13.719616,-129430.487997334,723755.787495954,275.637420654297,220,2.44033817724306,1.1685886814125 +-156.04569,56.5049007,13.719616,-125726.356885527,723755.778538773,266.314666748047,220,2.42539508499824,1.11431110519616 +-155.98546,56.5059084,13.719616,-122022.432245992,723755.787375138,253.200759887695,220,2.40346500472027,1.03465479415847 +-155.92522,56.5068859,13.719616,-118318.094280569,723755.773416025,239.646957397461,220,2.37957191947894,0.947868288796456 +-155.86498,56.5078333,13.719616,-114613.950963859,723755.766282571,226.798980712891,220,2.35564109840534,0.860944716120781 +-155.80474,56.5087506,13.719616,-110909.996216198,723755.765529139,213.598037719727,220,2.32959725860273,0.76634605630574 +-155.7445,56.5096379,13.719616,-107206.223664185,723755.781875088,192.98193359375,220,2.28551665352696,0.606232716813223 +-155.68425,56.5104949,13.719616,-103502.013708585,723755.765865334,157.209915161133,220,2.19647993333171,0.282825935454004 +-155.624,56.5113219,13.719616,-99797.9737856651,723755.767249823,110.426010131836,121,2.04307138069634,-0.274397714877961 +-155.56375,56.5121188,13.719616,-96094.0981058943,723755.774488562,79.1603012084961,22,1.89850743804748,-0.799495217235887 +-155.5035,56.5128855,13.719616,-92390.3808386237,723755.776054694,72.2636947631836,22,1.85892016279858,-0.943287500273202 +-155.44324,56.5136222,13.719616,-88686.2009878778,723755.780536821,59.8386192321777,22,1.77698156368721,-1.2409118798503 +-155.38298,56.5143287,13.719616,-84982.1673612163,723755.779753865,59.1637229919434,22,1.7720554950068,-1.25880476733756 +-155.32272,56.515005,13.719616,-81278.2738433134,723755.773372628,54.491886138916,22,1.73633184048893,-1.38856327709262 +-155.26246,56.5156513,13.719616,-77574.5138942107,723755.783379764,46.0859527587891,22,1.66356857031366,-1.65286024307418 +-155.20219,56.5162674,13.719616,-73870.2674649978,723755.776042519,42.7372360229492,22,1.63080643128624,-1.77186168326724 +-155.14192,56.5168534,13.719616,-70166.1426440037,723755.774462142,35.536678314209,22,1.55067683097552,-2.06291526286075 +-155.08165,56.5174093,13.719616,-66462.1333441828,723755.778362778,32.211799621582,22,1.50801498883366,-2.21787525042205 +-155.02138,56.517935,13.719616,-62758.2336495817,723755.776329252,26.1804504394531,22,1.41797711439526,-2.54491850975026 +-154.96111,56.5184306,13.719616,-59054.4372804719,723755.779267233,23.687442779541,22,1.37451817821201,-2.70277377038318 +-154.90083,56.5188961,13.719616,-55350.1237514609,723755.778608895,22,22,1.34242268082221,-2.81935377786993 +-154.84056,56.5193314,13.719616,-51646.5159090869,723755.780207874,19,22,1.27875360095283,-3.05061804892018 +-154.41859,56.5215349,13.58507894,-25718.3864638469,723755.782277221,19,22,1.27875360095283,-3.05061804892018 +-153.87601,56.5221977,12.14160991,7617.91781640047,723755.776268612,12.8199195861816,31,1.10788530104964,-3.67126048483688 +-153.81573,56.5221206,13.719616,11321.5234224451,723755.771346287,45.7897605895996,31,1.66076837283786,-1.66303135956222 +-153.75544,56.5220134,13.719616,15025.7620747021,723755.772801698,63.5569305419922,31,1.80316291495346,-1.14581373914964 +-153.69515,56.5218761,13.719616,18730.0254675864,723755.779538291,85.3543090820312,31,1.93122545120715,-0.680654054789272 +-153.63487,56.5217086,13.719616,22433.7053567558,723755.777087974,132.578964233398,130,2.1224746217906,0.014017520717789 +-153.57458,56.521511,13.719616,26138.0365864638,723755.782882758,140.429748535156,130,2.14745911816504,0.104768342835003 +-153.5143,56.5212832,13.719616,29841.7965353015,723755.778547323,124.454933166504,130,2.09501211592677,-0.0857341391592343 +-153.45402,56.5210253,13.719616,33545.6056299081,723755.778721699,92.7143783569336,31,1.96714709074481,-0.550176406931797 +-153.39373,56.5207372,13.719616,37250.0844598949,723755.777981894,86.3150482177734,31,1.93608651747905,-0.662997274603296 +-153.33345,56.520419,13.719616,40954.0102401034,723755.776957917,86.0447082519531,31,1.93472416638184,-0.667945722642081 +-153.27317,56.5200707,13.719616,44658.0034578471,723755.780850844,87.7190093994141,31,1.94309371859603,-0.637545120092095 +-153.21289,56.5196922,13.719616,48362.0703353335,723755.77867063,89.6465530395508,31,1.95253359535183,-0.603256793305954 +-153.15262,56.5192836,13.719616,52065.6024532685,723755.773909827,85.0774078369141,31,1.9298142492223,-0.685779943195416 +-153.09234,56.5188449,13.719616,55769.8346951418,723755.781882976,84.0310592651367,31,1.92443983813688,-0.7053013382673 +-153.03207,56.518376,13.719616,59473.5445184894,723755.775405364,89.1989135742188,31,1.95035956478425,-0.611153492857511 +-152.97179,56.517877,13.719616,63177.9666637642,723755.783204762,80.7904586791992,31,1.9073600737987,-0.767339917393649 +-152.91152,56.5173478,13.719616,66881.878607996,723755.775894218,65.1173706054688,31,1.81369685572343,-1.10755145958709 +-152.85125,56.5167885,13.719616,70585.900673545,723755.773831921,57.5559501647949,31,1.76009022788168,-1.30226603276324 +-152.79098,56.5161991,13.719616,74290.0389478597,723755.777281159,55.7130737304688,31,1.74595711946029,-1.3536015165405 +-152.73072,56.5155796,13.719616,77993.6851208883,723755.774775261,65.0504608154297,31,1.81325037743703,-1.10917319616089 +-152.67045,56.5149299,13.719616,81698.0742965307,723755.778383738,84.0548858642578,31,1.92456296277508,-0.704854114438094 +-152.61019,56.5142501,13.719616,85401.9835636306,723755.775519406,133.686264038086,134,2.12608678677641,0.0271379349607882 +-152.54993,56.5135402,13.719616,89106.0334046962,723755.778246319,253.321441650391,231,2.4036719509289,1.03540648185652 +-152.48968,56.5128002,13.719616,92809.6155075877,723755.772923509,300.200164794922,231,2.47741092631333,1.3032474876518 +-152.42942,56.51203,13.719616,96513.9650144996,723755.776139966,328.72802734375,231,2.51683673359736,1.44645327295312 +-152.36917,56.5112298,13.719616,100217.858697625,723755.782053766,335.278289794922,231,2.52540543255938,1.47757723333336 +-152.30892,56.5103994,13.719616,103921.917574768,723755.782713487,300.667449951172,231,2.47808641422703,1.3057010525578 +-152.24868,56.5095389,13.719616,107625.533067542,723755.773455483,175.035858154297,134,2.24312702813359,0.452261498180857 +-152.18843,56.5086482,13.719616,111329.940356039,723755.775388288,130.844314575195,134,2.11675485649624,-0.00675829941489303 +-152.12819,56.5077275,13.719616,115033.916128856,723755.778262572,214.48698425293,134,2.33140094296066,0.77289755271651 +-152.06795,56.5067767,13.719616,118738.081157492,723755.787566603,328.125,134,2.51603932075003,1.44355684188736 +-152.00772,56.5057957,13.719616,122441.827459067,723755.774160956,389.836395263672,231,2.59088238256077,1.71540820472058 +-151.94749,56.5047847,13.719616,126145.774850384,723755.77812816,554.477600097656,330,2.74388400612002,2.27115377249897 +-134.28067,54.8465273,12.4827832,1248457.99626005,723755.841170307,409,450,2.61172330800734,1.7911083945349 +-134.22556,54.8367768,13.719616,1252161.88213763,723755.807148662,225,251,2.35218251811136,0.848382165315956 +-134.17048,54.8269997,13.719616,1255865.65051189,723755.729916547,207,251,2.31597034545692,0.716849218251904 +-134.11542,54.8171961,13.719616,1259569.91646709,723755.808480714,203,251,2.30749603791321,0.686068114444982 +-134.06039,54.8073661,13.719616,1263274.06625296,723755.863633808,199,251,2.29885307640971,0.65467441131743 +-134.0054,54.7975095,13.719616,1266977.49597959,723755.682048052,197,251,2.29446622616159,0.638740119084559 +-133.95042,54.7876265,13.719616,1270682.04617393,723755.856040409,195,251,2.29003461136252,0.622643229225523 +-133.89548,54.777717,13.719616,1274385.88085853,723755.801375262,198,151,2.29666519026153,0.646727384342376 +-133.84057,54.7677811,13.719616,1278089.61502076,723755.7181876,189,151,2.27646180417324,0.573342919449214 +-133.78568,54.7578188,13.719616,1281793.86694291,723755.798222041,182,151,2.26007138798507,0.513808249563239 +-133.73082,54.7478301,13.719616,1285498.02610777,723755.848327558,191,151,2.28103336724773,0.589948141389748 +-133.67599,54.737815,13.719616,1289202.09638985,723755.867253709,219,151,2.34044411484012,0.805744934160936 +-133.62119,54.7277736,13.719616,1292906.07829694,723755.864365012,214,151,2.33041377334919,0.769311870921396 +-133.56642,54.7177059,13.719616,1296609.97566664,723755.838416196,216,151,2.33445375115093,0.783986223421782 +-133.51168,54.7076118,13.719616,1300313.7957099,723755.777566822,221,151,2.34439227368511,0.820085774002676 +-133.45697,54.6974914,13.719616,1304017.53889229,723755.691193355,206,251,2.31386722036915,0.709210067641479 +-133.40228,54.6873448,13.719616,1307721.82003627,723755.785580581,271,251,2.43296929087441,1.14182278283197 +-133.34762,54.6771719,13.719616,1311426.03193959,723755.853110847,300,251,2.47712125471966,1.30219531774308 +-133.293,54.6669728,13.719616,1315129.56060255,723755.705134608,334,251,2.52374646681156,1.47155139622134 +-133.2384,54.6567474,13.719616,1318833.64202059,723755.725351226,356,350,2.55144999797288,1.57217852877426 +-133.18383,54.6464959,13.719616,1322537.65873524,723755.736260721,408,350,2.61066016308988,1.78724674874291 +-133.12929,54.6362181,13.719616,1326241.62136772,723755.715491926,411,251,2.61384182187607,1.79880344159018 +-133.07478,54.6259143,13.719616,1329945.52336331,723755.693595535,413,350,2.6159500516564,1.80646113390103 +-133.02029,54.6155842,13.719616,1333649.99319471,723755.838458839,393.233947753906,350,2.5946510032745,1.72909691082431 +-132.96584,54.6052281,13.719616,1337353.79545056,723755.779550684,379.870819091797,350,2.57963593321211,1.67455789063002 +-132.91142,54.5948458,13.719616,1341057.55517071,723755.694801071,379,350,2.57863920996807,1.67093750731455 +-132.85702,54.5844375,13.719616,1344761.88352901,723755.806666443,378,350,2.57749179983723,1.66676978621586 +-132.80266,54.5740031,13.719616,1348465.55890684,723755.698981868,374,350,2.57287160220048,1.6499879096635 +-132.74832,54.5635427,13.719616,1352169.81030366,723755.786683867,345,350,2.53781909507327,1.52266719879587 +-132.69401,54.5530562,13.17394594,1355874.03050432,723755.855559408,269,350,2.42975228000241,1.13013768111856 +-158.38714,56.4090175,13.719616,-270182.409288887,720051.794419509,29.686466217041,20,1.47255850363246,-2.34666332496122 +-158.32716,56.4111947,13.719616,-266477.989730166,720051.758450357,44.6608963012695,20,1.64992743469577,-1.70240874120609 +-158.26718,56.4133421,13.719616,-262774.003884117,720051.766108654,115.566162109375,20,2.06283069082835,-0.202626260609906 +-158.2072,56.4154595,13.719616,-259070.447226135,720051.794134397,129.286743164062,120,2.11155399536871,-0.0256493115036251 +-158.1472,56.4175469,13.719616,-255366.083847839,720051.764634822,176.687698364258,120,2.24720631340886,0.46707862664455 +-158.0872,56.4196044,13.719616,-251662.136972315,720051.766903869,174.887359619141,120,2.2427584209936,0.450922611837443 +-158.02719,56.421632,13.719616,-247957.98567283,720051.762646198,181.752197265625,120,2.25947966990009,0.51165896058541 +-157.96718,56.4236296,13.719616,-244254.239596496,720051.778235799,188.818664550781,120,2.27604492169281,0.571828683290168 +-157.90716,56.4255972,13.719616,-240550.277783204,720051.776518516,163.997436523438,120,2.21483705955729,0.349504257550783 +-157.84713,56.4275349,13.719616,-236846.093580298,720051.769383638,150.033493041992,120,2.17618822051977,0.209120642689553 +-157.7871,56.4294426,13.719616,-233142.29660001,720051.781571546,80.1202087402344,20,1.90374207210698,-0.780481532218467 +-157.72706,56.4313203,13.719616,-229438.26587759,720051.777642856,40.8670501708984,20,1.61137329098452,-1.84244839561358 +-157.66701,56.4331681,13.719616,-225733.99478602,720051.769530205,82.7872695922852,20,1.91796355935872,-0.728825031303557 +-157.60696,56.4349858,13.719616,-222030.093508331,720051.769203203,113.663848876953,20,2.05562235800575,-0.228808982884615 +-157.5469,56.4367736,13.719616,-218325.9398543,720051.765211361,111.855918884277,20,2.04865896984319,-0.25410199623988 +-157.48684,56.4385313,13.719616,-214622.1439638,720051.768434304,149.787002563477,120,2.17547413005332,0.206526862293696 +-157.42677,56.4402591,13.719616,-210918.083684052,720051.768567075,174.79182434082,120,2.24252111521655,0.450060649521386 +-157.3667,56.4419569,13.719616,-207214.368546655,720051.786538928,184.97575378418,120,2.26711480576608,0.539391953335449 +-157.30662,56.4436246,13.719616,-203510.378131981,720051.779771846,197.263305664062,120,2.29504630659167,0.640847136778046 +-157.24653,56.4452624,13.719616,-199806.105298403,720051.771438614,165.401672363281,120,2.21853989635603,0.362954017698633 +-157.18644,56.4468701,13.719616,-196102.16007826,720051.769694311,43.4352226257324,120,1.63784205181607,-1.74630630133688 +-157.12634,56.4484479,13.719616,-192397.920412851,720051.767097644,47.2998085021973,120,1.67485938245859,-1.61184879064518 +-157.06624,56.4499956,13.719616,-188693.996291644,720051.770714044,47.8879241943359,120,1.68022601201684,-1.59235566030103 +-157.00614,56.4515132,13.719616,-184990.381657981,720051.779817815,60.6270523071289,120,1.78266645331053,-1.22026273810937 +-156.94603,56.4530009,13.719616,-181286.454509931,720051.788685719,93.0547866821289,120,1.96873871788771,-0.544395162853152 +-156.88591,56.4544585,13.719616,-177582.209818018,720051.776009091,117.281684875488,20,2.06923019644159,-0.179381429621859 +-156.82579,56.4558861,13.719616,-173878.256002316,720051.780103517,134.423110961914,20,2.12847394208365,0.0358087643986151 +-156.76566,56.4572836,13.719616,-170173.972541271,720051.763531891,108.09602355957,121,2.03380971820956,-0.308038716571621 +-156.70553,56.4586511,13.719616,-166469.967872853,720051.763523191,154.946701049805,121,2.19018233416602,0.259951257770464 +-156.6454,56.4599886,13.719616,-162766.2359637,720051.779437052,181.959701538086,121,2.25997521580098,0.513458924740327 +-156.58526,56.461296,13.719616,-159062.156258686,720051.775550312,183.889724731445,121,2.2645574626959,0.530102953366145 +-156.52512,56.4625733,13.719616,-155358.337646823,720051.776316012,197.499771118164,121,2.29556659666032,0.642736978812954 +-156.46497,56.4638206,13.719616,-151654.158692616,720051.769445357,216.48828125,121,2.33543439248521,0.787548192650776 +-156.40482,56.4650379,13.719616,-147950.228313321,720051.778305208,221.102722167969,121,2.34459408954954,0.820818826826271 +-156.34466,56.4662251,13.719616,-144245.925909367,720051.769457824,222.399810791016,121,2.34713441342957,0.830046008239146 +-156.28451,56.4673822,13.719616,-140542.475320567,720051.786343956,245.685699462891,220,2.39037987839664,0.98712588048415 +-156.22434,56.4685092,13.719616,-136838.025611875,720051.764932857,270.754302978516,220,2.43257536740253,1.14039194034517 +-156.16418,56.4696062,13.719616,-133134.415212613,720051.779330973,275.054992675781,220,2.43941953247743,1.16525190141642 +-156.10401,56.4706731,13.719616,-129430.408524343,720051.777223814,269.196197509766,220,2.43006892103415,1.13128781172418 +-156.04383,56.47171,13.719616,-125725.999130483,720051.770932428,258.359924316406,220,2.41222514864951,1.0664741373035 +-155.98366,56.4727168,13.719616,-122022.411229821,720051.787242259,243.399642944336,220,2.38631993680523,0.972379013801445 +-155.92348,56.4736934,13.719616,-118318.409160799,720051.77722547,230.551208496094,220,2.36276740303259,0.886829488576786 +-155.86329,56.47464,13.719616,-114613.986191458,720051.764395298,216.939880371094,220,2.33633939633434,0.790835424944656 +-155.80311,56.4755566,13.719616,-110910.366185101,720051.783382231,197.745132446289,220,2.29610580201682,0.644695526572289 +-155.74292,56.476443,13.719616,-107206.313770557,720051.77749669,161.320022583008,220,2.20768827413198,0.323537828419545 +-155.68273,56.4772994,13.719616,-103502.437229047,720051.785881065,113.641204833984,121,2.05553582950336,-0.229123279102996 +-155.62253,56.4781256,13.719616,-99798.116102349,720051.770804369,81.1374282836914,121,1.90922123827215,-0.760579636796845 +-155.56233,56.4789218,13.719616,-96093.9587107319,720051.770322852,70.0456085205078,22,1.84538091256833,-0.992465921596219 +-155.50213,56.4796879,13.719616,-92389.9592567314,720051.772911555,61.5644645690918,22,1.78933010673148,-1.19605844688845 +-155.44193,56.4804239,13.719616,-88686.1116596538,720051.778210383,48.9293403625488,22,1.68956936088898,-1.55841795034015 +-155.38173,56.4811297,13.719616,-84982.4100702567,720051.774721448,53.4734649658203,22,1.72813832636292,-1.41832445906002 +-155.32152,56.4818055,13.719616,-81278.2329776627,720051.77217792,48.0276908874512,22,1.68149170679417,-1.58775829560449 +-155.26131,56.4824512,13.719616,-77574.1894963977,720051.772464516,40.7631721496582,22,1.61026797301563,-1.84646322596573 +-155.2011,56.4830668,13.719616,-73870.2735435033,720051.775277662,36.5344734191895,22,1.5627028521277,-2.01923332146783 +-155.14089,56.4836523,13.719616,-70166.4790355234,720051.780327925,28.6583099365234,22,1.45725057521401,-2.40226609029481 +-155.08067,56.4842077,13.719616,-66462.1849337253,720051.777332312,29.3913078308105,22,1.46821891138963,-2.36242596263011 +-155.02045,56.484733,13.719616,-62758.0001085015,720051.777152851,23.565746307373,22,1.37228119805456,-2.71089912081273 +-154.96023,56.4852281,13.719616,-59053.9186362885,720051.768389291,20.426326751709,22,1.31019027486089,-2.93643107636605 +-154.90001,56.4856932,13.719616,-55349.9340991887,720051.773115105,19,22,1.27875360095283,-3.05061804892018 +-154.83979,56.4861281,13.719616,-51646.040724006,720051.768804952,14,22,1.14612803567824,-3.53235195710261 +-154.41821,56.4883297,13.71715565,-25718.3639641423,720051.778183996,17,22,1.23044892137827,-3.22607443266317 +-154.35798,56.4885237,13.719616,-22014.3645888169,720051.772399566,31,22,1.49136169383427,-2.27836477118343 +-154.17728,56.4889252,13.49398816,-10901.9443042133,720051.77567301,15.4149370193481,22,1.18794175467359,-3.38047259488788 +-154.11705,56.4889988,12.63523938,-7198.05319542845,720051.777645824,11.7396783828735,22,1.06965619925771,-3.81011949421715 +-154.05682,56.4890423,11.77541919,-3494.1739298713,720051.781296552,13.4454317092896,22,1.12857475121921,-3.59611049646399 +-153.99659,56.4890556,13.33460119,209.699581504981,720051.775450277,28.2659931182861,31,1.4512642488874,-2.4240101361807 +-153.93636,56.4890388,13.71664846,3913.57344686648,720051.771255184,21.2773571014404,31,1.32791768247909,-2.87204007199084 +-153.87612,56.488992,13.719616,7618.06868869367,720051.781020666,31.3809509277344,31,1.49666609974838,-2.2590976548752 +-153.81589,56.488915,13.719616,11321.9615173892,720051.780723462,47.3262138366699,31,1.67510176169145,-1.61096840008948 +-153.75566,56.4888078,13.719616,15025.8730065136,720051.770989216,78.4297256469727,31,1.89448069581827,-0.814121494359035 +-153.69543,56.4886706,13.719616,18729.8091724586,720051.774177121,112.051780700684,130,2.04941876263222,-0.251342211963668 +-153.6352,56.4885033,13.719616,22433.7761343989,720051.779197305,143.305953979492,130,2.15626423454753,0.136751038766632 +-153.57497,56.4883058,13.719616,26137.7800518581,720051.77497423,130.915237426758,130,2.11699019769844,-0.00590347299542527 +-153.51474,56.4880782,13.719616,29841.826961665,720051.772755153,96.4652862548828,31,1.98437105738288,-0.487614043892797 +-153.45451,56.4878205,13.719616,33545.9229516339,720051.772647108,84.6739196777344,31,1.92774966435426,-0.693279104727304 +-153.39428,56.4875327,13.719616,37250.0741093872,720051.774771325,78.5614852905273,31,1.89520968566716,-0.811473595153456 +-153.33406,56.4872148,13.719616,40953.6715675441,720051.773096429,74.0523681640625,31,1.86953895163696,-0.904717028308117 +-153.27383,56.4868668,13.719616,44657.9513228311,720051.77954767,67.567138671875,31,1.82973552784421,-1.04929442455162 +-153.21361,56.4864886,13.719616,48361.6896846559,720051.770243885,60.1260643005371,31,1.77906277696209,-1.23335231919855 +-153.15339,56.4860804,13.719616,52065.507440354,720051.773837081,59.6658325195312,31,1.775725704729,-1.24547351804438 +-153.09316,56.485642,13.719616,55770.0259052727,720051.77660973,63.2838554382324,31,1.80129292979025,-1.15260605900932 +-153.03294,56.4851735,13.719616,59474.021123713,720051.773684061,67.2779159545898,31,1.82787253000389,-1.05606136446019 +-152.97273,56.484675,13.719616,63177.4990087186,720051.774760252,62.7680473327637,31,1.79773861828276,-1.16551633290605 +-152.91251,56.4841463,13.719616,66881.6958900121,720051.776235,53.9319305419922,31,1.73184596652825,-1.40485725171368 +-152.85229,56.4835875,13.719616,70586.0027351721,720051.780554744,51.5272979736328,31,1.71203736920455,-1.47680773112992 +-152.79208,56.4829986,13.719616,74289.810673764,720051.776795857,50.3775253295898,31,1.70223683005173,-1.51240608668535 +-152.73187,56.4823796,13.719616,77993.7407444589,720051.775306135,55.9797782897949,31,1.74803117409246,-1.3460679581223 +-152.67166,56.4817305,13.719616,81697.7990306605,720051.776376595,85.5885925292969,31,1.93241588463371,-0.676330060800479 +-152.61145,56.4810513,13.719616,85401.9916152683,720051.780312411,137.855865478516,134,2.13942524915605,0.0755870374998204 +-152.55125,56.480342,13.719616,89105.7096258591,720051.774015578,267.526824951172,231,2.42736733530746,1.12147488125552 +-152.49105,56.4796026,13.719616,92809.5740990294,720051.770121353,293.438751220703,231,2.46751746577867,1.26731161511512 +-152.43085,56.4788331,13.719616,96513.5911160074,720051.768977298,323.144134521484,330,2.50939627733104,1.4194274120762 +-152.37065,56.4780335,13.719616,100217.766757413,720051.770945097,343.075164794922,330,2.53538928062422,1.5138414191788 +-152.31046,56.4772039,13.719616,103921.491864719,720051.771903006,316.840698242188,330,2.50084096170147,1.38835206377943 +-152.25026,56.4763441,13.719616,107626.002984213,720051.780678064,252.938827514648,231,2.40301550107648,1.03302206862311 +-152.19007,56.4754543,13.719616,111330.075707406,720051.788121162,258.220184326172,231,2.41199018680284,1.0656206888116 +-152.12989,56.4745343,13.719616,115033.716710066,720051.770676645,403.733551025391,231,2.60609484160683,1.77066419804398 +-152.06971,56.4735843,13.719616,118737.546406209,720051.767282782,572.625244140625,330,2.75787048994704,2.32195667389863 +-134.24246,54.8049586,12.87148202,1252161.54645221,720051.695177111,540,450,2.73239375982297,2.22941791830527 +-134.18741,54.7951892,13.719616,1255866.0100083,720051.839781452,249,251,2.39619934709574,1.00826385184101 +-134.1324,54.7853933,13.719616,1259569.73804467,720051.75912865,208,251,2.31806333496276,0.724451553535809 +-134.07741,54.7755709,13.719616,1263273.96440919,720051.830688477,203,251,2.30749603791321,0.686068114444982 +-134.02245,54.765722,13.719616,1266978.07808002,720051.864065355,199,251,2.29885307640971,0.65467441131743 +-133.96752,54.7558467,13.719616,1270682.07967867,720051.868601578,203,251,2.30749603791321,0.686068114444982 +-133.91262,54.7459449,13.719616,1274385.97641596,720051.832389236,208,251,2.31806333496276,0.724451553535809 +-133.85775,54.7360167,13.719616,1278089.76888521,720051.764779083,216,251,2.33445375115093,0.783986223421782 +-133.8029,54.7260622,13.719616,1281794.07259423,720051.868126438,199,251,2.29885307640971,0.65467441131743 +-133.74809,54.7160812,13.719616,1285497.66816926,720051.734469876,196,251,2.29225607135648,0.630712205991387 +-133.6933,54.7060739,13.719616,1289201.78272118,720051.770359772,235,251,2.37106786227174,0.916979125720317 +-133.63854,54.6960403,13.719616,1292905.80513833,720051.781528383,259,251,2.41329976408125,1.07037744727735 +-133.58381,54.6859803,13.719616,1296609.74262554,720051.756118619,275,251,2.43933269383026,1.16493647866368 +-133.52911,54.6758941,13.719616,1300313.59228977,720051.714099366,291,251,2.46389298898591,1.25414648087514 +-133.47443,54.6657816,13.719616,1304017.97627121,720051.839979896,300,350,2.47712125471966,1.30219531774308 +-133.41979,54.6556428,13.719616,1307721.66848197,720051.740375812,303,350,2.4814426285023,1.31789178076452 +-133.36517,54.6454777,13.719616,1311425.90264787,720051.807331684,283,350,2.45178643552429,1.21017202314816 +-133.31058,54.6352865,13.719616,1315130.06080422,720051.86445572,330,350,2.51851393987789,1.45254536488635 +-133.25603,54.625069,13.719616,1318833.53858791,720051.690757687,335,350,2.52504480703685,1.47626733850276 +-133.2015,54.6148254,13.719616,1322537.56285325,720051.70281817,376,350,2.57518784492766,1.65840116437012 +-133.147,54.6045556,13.719616,1326241.52582466,720051.69081166,399,350,2.60097289568675,1.75205982851334 +-133.09252,54.5942596,13.719616,1329946.04622031,720051.853798357,406,350,2.60852603357719,1.77949498121162 +-133.03808,54.5839376,13.719616,1333649.89098156,720051.811775062,398,350,2.59988307207369,1.74810127808407 +-132.98367,54.5735894,13.719616,1337353.68568844,720051.742094197,393,350,2.59439255037543,1.72815813612507 +-132.92928,54.5632151,13.719616,1341058.04557218,720051.856078679,385,350,2.5854607295085,1.69571521334091 +-132.87493,54.5528148,13.719616,1344761.74095989,720051.759804899,387,350,2.58771096501891,1.70388871099588 +-132.8206,54.5423884,13.719616,1348466.0089339,720051.845948186,376,350,2.57518784492766,1.65840116437012 +-132.76631,54.531936,13.719616,1352169.61979336,720051.718360942,379,350,2.57863920996807,1.67093750731455 +-132.71204,54.5214576,13.719616,1355873.80712193,720051.782525937,380,350,2.57978359661681,1.67509424626323 +-158.44309,56.3736743,13.719616,-273886.511978597,716347.79678764,16.4305725097656,20,1.21565269633221,-3.27981854529355 +-158.38317,56.3758796,13.719616,-270182.028512961,716347.764562911,26.8289165496826,20,1.4286031346177,-2.5063217713342 +-158.32325,56.378055,13.719616,-266477.984856717,716347.762243347,40.7565116882324,20,1.61019700606595,-1.84672099818297 +-158.26333,56.3802005,13.719616,-262774.375047505,716347.788817396,44.8043251037598,20,1.65131993984705,-1.6973507650361 +-158.20339,56.3823161,13.719616,-259069.962096225,716347.765267085,59.815990447998,20,1.77681729828624,-1.24150853867264 +-158.14345,56.3844017,13.719616,-255365.971757581,716347.75972811,150.296875,120,2.17694995075081,0.211887464308171 +-158.08351,56.3864574,13.719616,-251662.397348697,716347.782360264,79.1751327514648,120,1.898588800218,-0.799199686609498 +-158.02355,56.3884833,13.719616,-247958.001200202,716347.768665919,188.326400756836,120,2.27491120636456,0.567710705623379 +-157.96359,56.3904791,13.719616,-244254.010392433,716347.761209008,246.181213378906,120,2.39125490790814,0.990304237428193 +-157.90363,56.3924451,13.719616,-240550.416927263,716347.792458571,244.802444458008,120,2.38881575011292,0.981444520111015 +-157.84365,56.3943811,13.719616,-236845.985126342,716347.767904811,276.634155273438,120,2.44190580025276,1.17428273562788 +-157.78367,56.3962871,13.719616,-233141.940009244,716347.760202813,290.982635498047,120,2.46386707306704,1.25405234686068 +-157.72369,56.3981632,13.719616,-229438.274943943,716347.779598881,222.625381469727,120,2.34757467663775,0.831645169874887 +-157.6637,56.4000093,13.719616,-225734.369054586,716347.780092491,217.412567138672,120,2.33728464407978,0.794268834556666 +-157.6037,56.4018255,13.719616,-222030.215726294,716347.773632018,200.795318603516,120,2.30275358333174,0.66884216577378 +-157.5437,56.4036117,13.719616,-218326.425085223,716347.782782085,186.193298339844,120,2.26996404535422,0.549741204773505 +-157.48369,56.405368,13.719616,-214622.375021228,716347.785529444,166.867324829102,120,2.22237130351149,0.37687078207976 +-157.42367,56.4070943,13.719616,-210918.060124993,716347.771590328,107.531944274902,120,2.03153749831182,-0.316292067796338 +-157.36365,56.4087906,13.719616,-207214.089893434,716347.773033447,55.8506507873535,120,1.74702823800149,-1.34971090827117 +-157.30363,56.4104569,13.719616,-203510.458309577,716347.789066468,183.905685424805,120,2.26459515561357,0.530239864801761 +-157.24359,56.4120932,13.719616,-199805.928330081,716347.758738371,221.136993408203,120,2.34466140060292,0.821063319784646 +-157.18356,56.4136996,13.719616,-196102.339938436,716347.784357356,180.53385925293,120,2.25655866611795,0.501049041111186 +-157.12352,56.4152759,13.719616,-192398.457167695,716347.783277169,90.5217132568359,120,1.95675276502362,-0.587931564787101 +-157.06347,56.4168223,13.719616,-188694.272936846,716347.778716122,93.9517440795898,120,1.97290484656652,-0.52926259436021 +-157.00342,56.4183387,13.719616,-184990.39726948,716347.788339308,128.332397460938,120,2.10833630767949,-0.0373368716103734 +-156.94336,56.419825,13.719616,-181286.20912263,716347.772997684,120.719047546387,120,2.08177580026836,-0.133812215651191 +-156.8833,56.4212814,13.719616,-177582.316984601,716347.78269414,128.074920654297,120,2.10746409549188,-0.0405049952299455 +-156.82323,56.4227077,13.719616,-173878.100294163,716347.768279937,119.239646911621,120,2.07642068134448,-0.153263536085845 +-156.76316,56.4241041,13.719616,-170174.167577615,716347.778672228,107.546333312988,121,2.03159560813044,-0.316080996348914 +-156.70309,56.4254704,13.719616,-166470.513743664,716347.790930529,115.253601074219,121,2.06165450371227,-0.206898507932734 +-156.64301,56.4268067,13.719616,-162766.516775441,716347.791050334,174.95329284668,121,2.24292212087828,0.451517216543216 +-156.58292,56.428113,13.719616,-159062.170641538,716347.780079752,190.721298217773,121,2.28039919426241,0.587644644096082 +-156.52283,56.4293892,13.719616,-155358.085245624,716347.771328694,205.714202880859,121,2.31326427720686,0.707020005978919 +-156.46274,56.4306354,13.719616,-151654.254110439,716347.775344819,219.096206665039,121,2.34063485844294,0.80643776937002 +-156.40264,56.4318516,13.719616,-147950.055688972,716347.769267039,220.824722290039,121,2.34404769293899,0.818834158379638 +-156.34254,56.4330378,13.719616,-144246.099458281,716347.775919606,223.561141967773,220,2.34939631935967,0.838261896189493 +-156.28244,56.4341939,13.719616,-140542.3797652,716347.783600222,252.965713500977,220,2.4030616617039,1.03318973719746 +-156.22233,56.43532,13.719616,-136838.274656421,716347.782309399,269.294616699219,220,2.43022767178807,1.13186443977442 +-156.16222,56.436416,13.719616,-133134.393969284,716347.782092363,273.592620849609,220,2.43710437971652,1.15684260577841 +-156.1021,56.437482,13.719616,-129430.11576886,716347.774093883,261.961395263672,220,2.4182372949103,1.08831196856005 +-156.04198,56.4385179,13.719616,-125726.049870562,716347.767271085,247.63037109375,220,2.39380390848029,0.999562935063467 +-155.98186,56.4395238,13.719616,-122022.189870467,716347.772286762,233.253570556641,220,2.36782830048361,0.905212112642843 +-155.92173,56.4404997,13.719616,-118317.914214391,716347.770853843,221.317123413086,220,2.34501501680173,0.822347754750814 +-155.86161,56.4414455,13.719616,-114614.448197559,716347.787555654,208.632217407227,220,2.3193813738978,0.729239047153629 +-155.80147,56.4423612,13.719616,-110909.939208909,716347.770173433,171.855422973633,121,2.2351632410433,0.423334750377779 +-155.74134,56.4432469,13.719616,-107206.227419344,716347.781202324,120.892280578613,121,2.08239857042947,-0.131550136669732 +-155.6812,56.4441025,13.719616,-103502.076041477,716347.77623379,86.6497039794922,121,1.93776708337662,-0.656892979582045 +-155.62106,56.444928,13.719616,-99798.0945121823,716347.771566732,76.9733963012695,22,1.88634064938083,-0.843688466420405 +-155.56092,56.4457235,13.719616,-96094.2764929956,716347.777964466,69.423583984375,22,1.84150703031579,-1.00653696765351 +-155.50077,56.4464889,13.719616,-92390.0006767509,716347.769991346,57.2406539916992,22,1.75770458706125,-1.31093136115273 +-155.44063,56.4472243,13.719616,-88686.4917689625,716347.786820781,47.3854827880859,22,1.67564530980273,-1.60899407820524 +-155.38048,56.4479295,13.719616,-84982.5131603626,716347.778539166,47.1300239562988,22,1.67329766051257,-1.61752141051293 +-155.32032,56.4486047,13.719616,-81278.0582983974,716347.768791335,46.4269752502441,22,1.66677039000003,-1.64123032008298 +-155.26017,56.4492499,13.719616,-77574.3521590918,716347.782295944,38.5962867736816,22,1.58654552458702,-1.93262992971934 +-155.20001,56.4498649,13.719616,-73870.158070921,716347.772526795,32.6196746826172,22,1.51347962548878,-2.19802613032803 +-155.13985,56.4504499,13.719616,-70166.085052878,716347.773737755,26.5330295562744,22,1.42378684080234,-2.52381592517872 +-155.07969,56.4510048,13.719616,-66462.1272357603,716347.774502139,23.5077419281006,22,1.3712109143115,-2.71478669685691 +-155.01953,56.4515296,13.719616,-62758.2785382774,716347.774559313,22.0942306518555,22,1.34427888349636,-2.81261151994441 +-154.95936,56.4520244,13.719616,-59053.9172050563,716347.77592341,21,22,1.32221929473392,-2.8927382427631 +-154.8992,56.452489,13.719616,-55350.2685113548,716347.774398702,19,22,1.27875360095283,-3.05061804892018 +-154.83903,56.4529236,13.719616,-51646.0950374729,716347.774846021,14,22,1.14612803567824,-3.53235195710261 +-154.53818,56.4546452,13.719616,-33126.3780676419,716347.777257102,12,22,1.07918124604762,-3.77552180555717 +-154.478,56.4548993,13.719616,-29422.0066204925,716347.778903976,11,22,1.04139268515823,-3.91278064463658 +-154.29748,56.4554809,13.719616,-18310.3889789106,716347.775966714,13,22,1.11394335230684,-3.64925591353076 +-154.2373,56.4556146,13.719616,-14606.1743219513,716347.774702286,17,22,1.23044892137827,-3.22607443266317 +-154.17712,56.4557182,13.719616,-10901.9836525119,716347.772796546,37.8535194396973,22,1.5781062643429,-1.96328373173068 +-154.11695,56.4557917,13.719616,-7198.42639786701,716347.771284665,45.755126953125,22,1.66043976469096,-1.66422495814586 +-154.05677,56.4558352,13.719616,-3494.26543811865,716347.778560633,44.8628997802734,22,1.65188734142417,-1.69528980055546 +-153.99659,56.4558485,13.719616,209.889770401408,716347.773937631,41.1229515075684,31,1.61408427761779,-1.8326013183689 +-153.93641,56.4558318,13.719616,3914.04532204053,716347.779717437,35.6040382385254,31,1.55149925879441,-2.05992797027826 +-153.87624,56.4557849,13.719616,7617.59180091822,716347.772452797,45.7000007629395,31,1.65991620732019,-1.66612666795467 +-153.81606,56.455708,13.719616,11321.7662859729,716347.776210154,80.5133895874023,31,1.90586811068303,-0.772759153278458 +-153.75588,56.455601,13.719616,15025.9593606741,716347.779282297,88.0810928344727,31,1.94488269434967,-0.631047049530352 +-153.69571,56.4554639,13.719616,18729.5615977391,716347.778899231,88.5005722045898,31,1.94694607865819,-0.623552248773287 +-153.63553,56.4552967,13.719616,22433.810107351,716347.780208169,82.3709106445312,31,1.91577386731559,-0.736778617804566 +-153.57535,56.4550994,13.719616,26138.0954620071,716347.781025171,85.154182434082,31,1.93020598363667,-0.68435705199029 +-153.51518,56.454872,13.719616,29841.8082340593,716347.776949396,74.0136413574219,31,1.86931177135617,-0.905542211931654 +-153.45501,56.4546145,13.719616,33545.5700207305,716347.771465739,74.3509063720703,31,1.87128626714162,-0.898370279661682 +-153.39483,56.454327,13.719616,37250.0023174111,716347.781457667,65.1628570556641,31,1.81400011763014,-1.10644992578234 +-153.33466,56.4540093,13.719616,40953.8803765232,716347.774092895,53.6445846557617,31,1.72952588710673,-1.41328444238924 +-153.27449,56.4536616,13.719616,44657.825581251,716347.776878892,40.4284019470215,31,1.60668657489027,-1.85947188618984 +-153.21432,56.4532838,13.719616,48361.8441170156,716347.778825458,31.8311939239502,31,1.5028529284375,-2.23662532717962 +-153.15415,56.4528759,13.719616,52065.9420673084,716347.780110081,30.1304378509521,31,1.47900544282074,-2.32324620168973 +-153.09399,56.4524379,13.719616,55769.5100027832,716347.7725267,40.9004898071289,31,1.61172850896723,-1.84115814251104 +-153.03382,56.4519698,13.719616,59473.7850313242,716347.772518658,48.2120018005371,31,1.68315516410857,-1.58171614384061 +-152.97366,56.4514717,13.719616,63177.5420379889,716347.774105417,51.0334701538086,31,1.70785510032147,-1.49199892545168 +-152.91349,56.4509435,13.719616,66882.0182820767,716347.784836529,51.6557350158691,31,1.71311854555511,-1.47288059002625 +-152.85333,56.4503851,13.719616,70585.9890127977,716347.774223789,54.7754936218262,31,1.73858629999393,-1.38037443668361 +-152.79317,56.4497968,13.719616,74290.075246186,716347.785499439,51.7689361572266,31,1.71406924039632,-1.46942739500766 +-152.73302,56.4491783,13.719616,77993.6681282357,716347.773738829,58.9917259216309,31,1.77079110251387,-1.2633974017654 +-152.67286,56.4485298,13.719616,81698.0043488373,716347.784466882,91.4964218139648,31,1.96140411027589,-0.571036551204736 +-152.61271,56.4478512,13.719616,85401.8591654138,716347.782790098,140.158508300781,134,2.14661946667655,0.101718488968414 +-152.55256,56.4471425,13.719616,89105.8541697564,716347.780771247,252.721435546875,231,2.40264207984991,1.03166569614317 +-152.49241,56.4464037,13.719616,92809.9954405714,716347.778743092,287.684295654297,231,2.45891615491489,1.23606919899933 +-152.43227,56.4456349,13.719616,96513.6732801899,716347.773670489,315.900604248047,330,2.49955045661532,1.38366458095968 +-152.37213,56.444836,13.719616,100217.50952174,716347.768180466,368.757690429688,330,2.56674108627801,1.62772012600965 +-152.31199,56.4440071,13.719616,103921.50995865,716347.773798324,388.116333007812,330,2.58896191943651,1.70843253449854 +-152.25185,56.443148,13.719616,107625.681224023,716347.768612407,503.173522949219,330,2.70171778041102,2.11799400528483 +-152.19171,56.442259,13.719616,111330.028512717,716347.786475944,657.199951171875,330,2.81769752249616,2.53926553245221 +-134.20432,54.7633747,13.28747031,1255865.87374588,716347.801962808,674,450,2.82865989653532,2.57908400393552 +-134.14935,54.7535864,13.719616,1259569.67789264,716347.741145561,228,251,2.35793484700045,0.869276265719263 +-134.0944,54.7437716,13.719616,1263273.97719533,716347.829695774,210,251,2.32221929473392,0.739547185653671 +-134.03949,54.7339304,13.719616,1266977.5412674,716347.697062355,207,251,2.31597034545692,0.716849218251904 +-133.9846,54.7240628,13.719616,1270681.60503529,716347.722945323,206,251,2.31386722036915,0.709210067641479 +-133.92974,54.7141687,13.719616,1274385.56019449,716347.70520963,214,251,2.33041377334919,0.769311870921396 +-133.8749,54.7042482,13.719616,1278090.02285379,716347.845651318,224,251,2.35024801833416,0.841355509963957 +-133.8201,54.6943014,13.719616,1281793.76254419,716347.76926553,230,251,2.36172783601759,0.883053484456362 +-133.76532,54.6843282,13.719616,1285498.01748269,716347.849619282,217,251,2.33645973384853,0.791272525143927 +-133.71058,54.6743286,13.719616,1289201.56051894,716347.698873337,236,251,2.37291200297011,0.923677571106958 +-133.65586,54.6643028,13.719616,1292905.61983642,716347.724680179,301,350,2.47856649559384,1.30744484511092 +-133.60117,54.6542506,13.719616,1296609.59046268,716347.710994624,318,350,2.50242711998443,1.39411344339779 +-133.5465,54.6441722,13.719616,1300314.08502323,716347.873577615,326,350,2.51321760006794,1.43330754697073 +-133.49187,54.6340674,13.719616,1304017.88305712,716347.79893844,329,350,2.51719589794997,1.44775786039755 +-133.43727,54.6239365,13.719616,1307721.59375428,716347.712879207,318,350,2.50242711998443,1.39411344339779 +-133.38269,54.6137793,13.719616,1311425.8431893,716347.790434652,326,350,2.51321760006794,1.43330754697073 +-133.32814,54.6035959,13.719616,1315130.01625328,716347.844616338,321,350,2.50650503240487,1.40892558526091 +-133.27363,54.5933864,13.719616,1318833.49779738,716347.686199758,313,350,2.49554433754645,1.36911321304133 +-133.21914,54.5831506,13.719616,1322537.52944454,716347.689401883,227,350,2.35602585719312,0.862342269859097 +-133.16468,54.5728887,13.719616,1326241.49261048,716347.676154381,292,251,2.46538285144842,1.25955808658806 +-133.11024,54.5626007,13.719616,1329946.00654548,716347.845502069,275,251,2.43933269383026,1.16493647866368 +-133.05584,54.5522866,13.719616,1333649.84395692,716347.796275019,341,251,2.5327543789925,1.5042707043766 +-133.00147,54.5419463,13.719616,1337353.62754351,716347.716400473,359,350,2.55509444857832,1.585416213603 +-132.94712,54.5315801,13.719616,1341057.966162,716347.838335366,371,350,2.56937390961505,1.63728329185235 +-132.89281,54.5211877,13.719616,1344761.64288109,716347.725863915,374,350,2.57287160220048,1.6499879096635 +-132.83852,54.5107693,13.719616,1348465.88549267,716347.803364691,378,350,2.57749179983723,1.66676978621586 +-132.78426,54.5003249,13.719616,1352170.08216399,716347.867720163,380,350,2.57978359661681,1.67509424626323 +-132.73004,54.4898545,13.719616,1355873.62105697,716347.713588259,382,350,2.58206336291171,1.68337500815639 +-132.67584,54.4793582,9.181134432,1359577.73335508,716347.758122138,380,350,2.57978359661681,1.67509424626323 +-158.37922,56.3427403,13.50426502,-270182.438630012,712643.791910374,37.8927574157715,20,1.57855620957379,-1.96164940222494 +-158.31935,56.3449138,13.719616,-266478.162180087,712643.7712189,48.7032890319824,20,1.68755829099303,-1.56572273021871 +-158.25948,56.3470575,13.719616,-262774.318261073,712643.788057012,78.8790054321289,20,1.89696142604495,-0.805110774104833 +-158.1996,56.3491712,13.719616,-259070.286281232,712643.780160151,38.2548522949219,20,1.5826865294571,-1.94664690149807 +-158.13971,56.3512551,13.719616,-255366.058858157,712643.770479434,90.5055236816406,120,1.95667508562786,-0.588213718524396 +-158.07982,56.353309,13.719616,-251662.247497176,712643.775353024,115.260452270508,120,2.06168031937687,-0.206804738070373 +-158.01992,56.3553331,13.719616,-247958.228782485,712643.778752019,117.813774108887,120,2.07119606863255,-0.172240820708484 +-157.96001,56.3573272,13.719616,-244253.998105775,712643.759144862,73.3432540893555,120,1.8653601748051,-0.919895538503084 +-157.9001,56.3592915,12.01070284,-240550.164228738,712643.775764168,34.141357421875,120,1.53328078418089,-2.12610267014491 +-157.78026,56.3631302,13.64062041,-233142.434141333,712643.78816435,34.5013580322266,120,1.53783618998036,-2.10955613603897 +-157.72032,56.3650047,13.719616,-229437.909249843,712643.760975427,170.196670532227,120,2.23095105995759,0.408034906398283 +-157.66039,56.3668492,13.719616,-225734.37460486,712643.78150959,186.037200927734,120,2.26959979659531,0.548418149314214 +-157.60044,56.3686638,13.719616,-222029.975384271,712643.758071983,218.448135375977,120,2.33934834202164,0.801764774519538 +-157.54049,56.3704485,13.719616,-218325.937750337,712643.758914548,62.6608581542969,120,1.7969963383453,-1.16821250550669 +-157.48054,56.3722033,13.719616,-214622.255723373,712643.78320663,52.9774360656738,120,1.72409093603984,-1.43302573595367 +-157.42058,56.373928,13.719616,-210918.308400427,712643.776095608,58.7901306152344,120,1.76930442507108,-1.26879743857763 +-157.36061,56.3756229,13.719616,-207214.088046308,712643.771864519,61.8034782409668,120,1.79101291745695,-1.18994599801152 +-157.30064,56.3772878,13.719616,-203510.205885805,712643.779764602,107.597831726074,120,2.03180351966783,-0.315325802301243 +-157.24066,56.3789227,13.719616,-199806.039833362,712643.768932689,151.444046020508,120,2.18025220384076,0.223882190087734 +-157.18068,56.3805277,13.719616,-196102.199408676,712643.780947751,168.552612304688,120,2.22673548780163,0.392722745083763 +-157.12069,56.3821026,13.719616,-192398.063601576,712643.763809893,171.475982666016,120,2.23420330032017,0.419847971677016 +-157.0607,56.3836477,13.719616,-188694.240891488,712643.780292383,169.894287109375,120,2.23017877546358,0.405229748684114 +-157.0007,56.3851627,13.719616,-184990.110759456,712643.768396343,166.832641601562,120,2.22228102640089,0.376542869846393 +-156.9407,56.3866478,13.719616,-181286.282236549,712643.778668064,145.134750366211,120,2.16177141026944,0.156754672893047 +-156.88069,56.3881029,13.719616,-177582.133743553,712643.77253295,130.911773681641,120,2.11697870701698,-0.00594521043025542 +-156.82068,56.389528,13.719616,-173878.275326784,712643.777166734,106.211753845215,121,2.02617258028271,-0.335778981378099 +-156.76066,56.3909231,13.719616,-170174.084890886,712643.766279355,129.427062988281,121,2.11202509609767,-0.0239381391905009 +-156.70064,56.3922883,13.719616,-166470.172026485,712643.77710291,97.5993423461914,121,1.98944689126933,-0.469177166429976 +-156.64061,56.3936234,13.719616,-162765.915552941,712643.762203205,164.775604248047,121,2.21689291291492,0.356971703744655 +-156.58058,56.3949286,13.719616,-159061.924615358,712643.768869082,191.342391967773,121,2.28181119876798,0.592773447486536 +-156.52055,56.3962037,13.719616,-155358.194060947,712643.774201458,207.814315795898,121,2.31767546168609,0.723042687084867 +-156.46051,56.3974489,13.719616,-151654.100932516,712643.777058705,208.923095703125,121,2.31998645234026,0.731436864763225 +-156.40047,56.398664,13.719616,-147950.256105215,712643.778519201,216.642562866211,121,2.33574378470847,0.788671993515014 +-156.34042,56.3998491,13.719616,-144246.037053147,712643.767439919,223.885238647461,220,2.35002546032629,0.840547115754988 +-156.28037,56.4010042,13.719616,-140542.053813199,712643.766102518,257.895080566406,220,2.41144305790668,1.06363336049461 +-156.22032,56.4021293,13.719616,-136838.30035106,712643.773966927,267.61962890625,220,2.42751796415197,1.12202200821252 +-156.16026,56.4032244,13.719616,-133134.154561258,712643.770460078,270.886047363281,220,2.43278663622849,1.14115932902317 +-156.1002,56.4042895,13.719616,-129430.22647796,712643.776232345,254.768249511719,220,2.40614530309403,1.04439040288528 +-156.04014,56.4053246,13.719616,-125726.510064208,712643.79078564,240.500030517578,220,2.38111513581844,0.953473691019314 +-155.98007,56.4063296,13.719616,-122022.383544453,712643.78411361,226.23681640625,220,2.35456328078845,0.857029774896473 +-155.92,56.4073046,13.719616,-118318.456597692,712643.78638323,212.28645324707,121,2.32692228117609,0.75662977477761 +-155.85992,56.4082495,13.719616,-114614.107426606,712643.768731047,184.285568237305,121,2.26549132610181,0.533495011807579 +-155.79984,56.4091645,13.719616,-110909.945426571,712643.771386556,136.307678222656,121,2.13452032036739,0.0577709361333552 +-155.73976,56.4100494,13.719616,-107205.965171262,712643.771623333,93.3950576782227,121,1.97032389464693,-0.538637348409186 +-155.67968,56.4109043,13.719616,-103502.160306745,712643.780176364,79.7815322875977,121,1.90190237313273,-0.787163843995318 +-155.61959,56.4117291,13.719616,-99797.9089924425,712643.770468183,72.7108840942383,22,1.8615994252781,-0.933555654209951 +-155.55951,56.4125239,13.719616,-96094.4370337557,712643.783874797,64.8084411621094,22,1.81163157549055,-1.11505314688256 +-155.49942,56.4132886,13.719616,-92390.5064983535,712643.779376707,59.7050895690918,22,1.77601135420403,-1.24443595761857 +-155.43932,56.4140233,13.719616,-88686.1110700258,712643.769439341,46.8423881530762,22,1.67063902848538,-1.62717832088483 +-155.37923,56.414728,13.719616,-84982.4768444656,712643.780984844,47.800350189209,22,1.67943107830007,-1.59524308645701 +-155.31913,56.4154026,13.719616,-81278.3658572786,712643.77638153,45.276927947998,22,1.65587695217991,-1.68079839554234 +-155.25903,56.4160472,13.719616,-77574.3878910662,712643.779818629,38.3688697814941,22,1.58397900652462,-1.94195225587916 +-155.19892,56.4166617,13.719616,-73869.921030438,712643.768719529,28.6445198059082,22,1.45704154617396,-2.40302534343109 +-155.13882,56.4172462,13.719616,-70166.1911474117,712643.776751891,23.5536613464355,22,1.372058426495,-2.71170829070237 +-155.07871,56.4178006,13.719616,-66461.9602351676,712643.770801464,22.493350982666,22,1.35205415996527,-2.78436949652447 +-155.01861,56.418325,13.719616,-62758.4541849759,712643.782333474,22.2260036468506,22,1.34686138127093,-2.80323115090891 +-154.9585,56.4188193,13.719616,-59054.4349689491,712643.780492369,20,22,1.30102999566398,-2.9697038250132 +-154.89839,56.4192835,13.719616,-55350.5125783269,712643.77505393,21,22,1.32221929473392,-2.8927382427631 +-154.83827,56.4197177,13.719616,-51646.0647226512,712643.76917625,15,22,1.17609125905568,-3.42351697744033 +-154.65793,56.42084,13.61007983,-40534.436762428,712643.779046268,14,22,1.14612803567824,-3.53235195710261 +-154.59781,56.421154,13.719616,-36830.2910000637,712643.781665873,16,22,1.20411998265592,-3.32170865313004 +-154.53769,56.4214379,13.719616,-33126.2056423153,712643.780708877,20,22,1.30102999566398,-2.9697038250132 +-154.47757,56.4216917,13.719616,-29422.1746079819,712643.776042027,21,22,1.32221929473392,-2.8927382427631 +-154.41745,56.4219155,13.719616,-25718.191745538,712643.77869958,21,22,1.32221929473392,-2.8927382427631 +-154.35733,56.4221092,13.719616,-22014.2510636748,712643.77742331,23,22,1.36172783601759,-2.74923194396041 +-154.29721,56.4222728,13.719616,-18310.3464806204,712643.772122281,25,22,1.39794000867204,-2.61769899689636 +-154.23709,56.4224064,13.719616,-14606.4718746347,712643.773873259,36,22,1.55630250076729,-2.04248122445101 +-154.17696,56.4225099,13.719616,-10902.005153436,712643.769818452,51.5817451477051,22,1.71249603138853,-1.47514173916252 +-154.11684,56.4225834,13.719616,-7198.17235578727,712643.774903869,55.279899597168,22,1.74256724557389,-1.36591450606221 +-154.05672,56.4226268,13.719616,-3494.35136904603,712643.775742138,26.895393371582,22,1.42967790064828,-2.50241791434238 +-153.99659,56.4226401,13.719616,210.079959301968,712643.772344494,39.5413551330566,31,1.59705154906273,-1.89446905010563 +-153.93647,56.4226234,13.719616,3913.89556033051,712643.776352804,54.6109619140625,31,1.73727982623872,-1.38511992226731 +-153.87635,56.4225766,13.719616,7617.71757705346,712643.776095187,73.6707611083984,31,1.86729515666729,-0.912867132080796 +-153.81623,56.4224997,13.719616,11321.5520917124,712643.771593633,80.5097198486328,31,1.9058483154213,-0.77283105531919 +-153.7561,56.4223928,13.719616,15026.0212158023,712643.776300249,87.8000030517578,31,1.94349453100134,-0.636089255032772 +-153.69598,56.4222558,13.719616,18729.8989116916,712643.775144312,81.3605499267578,31,1.91041387537867,-0.756247638413472 +-153.63586,56.4220888,13.719616,22433.8072705077,712643.78104832,78.1674957275391,31,1.89302619857433,-0.819404643503881 +-153.57574,56.4218916,13.719616,26137.7524863722,712643.771783815,71.9196243286133,31,1.85684741019853,-0.950816329339087 +-153.51562,56.4216645,13.719616,29841.7404272788,712643.78090336,75,31,1.8750612633917,-0.8846584157902 +-153.4555,56.4214072,13.719616,33545.7773885808,712643.775053511,65.0662002563477,31,1.81335544549389,-1.10879155898895 +-153.39538,56.4211199,13.719616,37249.8692788733,712643.776661471,54.6096992492676,31,1.73726978476218,-1.38515639577619 +-153.33526,56.4208025,13.719616,40954.0222606817,712643.774708778,43.6264305114746,31,1.63974968072492,-1.73937724864843 +-153.27515,56.4204551,13.719616,44657.6262229479,712643.773772835,32.5500755310059,31,1.51255200066645,-2.20139552845322 +-153.21503,56.4200776,13.719616,48361.9194884007,712643.775754703,26.7932777404785,31,1.42802584602805,-2.50841864826639 +-153.15492,56.4196701,13.719616,52065.6758549797,712643.777977538,24.2225513458252,31,1.38421988517602,-2.66753440154701 +-153.09481,56.4192325,13.719616,55769.5175947407,712643.776204138,28.8324718475342,31,1.45988187664857,-2.39270845243629 +-153.03469,56.4187648,13.719616,59474.0668576734,712643.779595191,41.1700859069824,31,1.61458177321292,-1.830794272368 +-152.97458,56.4182671,13.719616,63178.0974104163,712643.782169299,45.9015808105469,31,1.6618276425193,-1.65918378973358 +-152.91448,56.4177393,13.719616,66881.6154839655,712643.771334226,52.8762817382812,31,1.7232609079503,-1.43604063488847 +-152.85437,56.4171815,13.719616,70585.8591050221,712643.778073488,54.7778244018555,31,1.73860477948728,-1.38030731388923 +-152.79427,56.4165936,13.719616,74289.6023834032,712643.770797083,69.6871490478516,31,1.84315269757898,-1.00055943443343 +-152.73416,56.4159757,13.719616,77994.0833247375,712643.782747243,79.6362762451172,31,1.9011109444241,-0.790038538961326 +-152.67406,56.4153277,13.719616,81698.0760580913,712643.780131512,112.311332702637,134,2.05042358067731,-0.247692426020294 +-152.61397,56.4146497,13.719616,85401.5864273935,712643.772731668,165.678283691406,134,2.2192655869283,0.365589932989829 +-152.55387,56.4139416,13.719616,89105.8528619091,712643.774875685,335.056518554688,231,2.52511807159231,1.47653345627999 +-152.49378,56.4132035,13.719616,92809.6490437804,712643.771769367,346.474395751953,231,2.5396711460344,1.52939437651465 +-152.43369,56.4124354,13.719616,96513.5970880295,712643.776617765,291.71826171875,330,2.4649636170389,1.25803530755127 +-152.3736,56.4116372,13.719616,100217.703311942,712643.778630255,374.207336425781,330,2.57311229769633,1.65086218440576 +-152.31351,56.4108089,13.719616,103921.973789322,712643.778181141,458.902435302734,430,2.66172036241406,1.97271196672018 +-134.11137,54.7119683,13.719616,1263273.48970415,712643.682429761,222,251,2.34635297445064,0.827207598822789 +-134.05649,54.7021347,13.719616,1266977.73485024,712643.754737489,214,251,2.33041377334919,0.769311870921396 +-134.00164,54.6922747,13.719616,1270681.86045391,712643.792482694,217,251,2.33645973384853,0.791272525143927 +-133.94682,54.6823883,13.719616,1274385.87041128,712643.794367582,218,251,2.3384564936046,0.798525326509967 +-133.89203,54.6724756,13.719616,1278089.76529541,712643.769722105,232,251,2.3654879848909,0.896711418417552 +-133.83727,54.6625364,13.719616,1281793.55561853,712643.696018383,237,251,2.3747483460101,0.930347693172715 +-133.78253,54.652571,13.719616,1285497.8513517,712643.797399862,239,251,2.37839790094814,0.94360391839434 +-133.72782,54.6425792,13.719616,1289202.04693491,712643.858904226,253,251,2.40312052117582,1.03340353159963 +-133.67315,54.6325611,13.719616,1292905.52681484,712643.695195461,278,251,2.44404479591808,1.18205217841445 +-133.6185,54.6225167,13.719616,1296609.52697,712643.693815962,322,350,2.50785587169583,1.41383221913359 +-133.56387,54.612446,13.719616,1300314.05123308,712643.85518133,336,350,2.52633927738984,1.48096922430347 +-133.50928,54.6023491,13.719616,1304017.86791234,712643.797603176,347,350,2.54032947479087,1.5317856144639 +-133.45472,54.592226,13.719616,1307721.59687401,712643.715068845,349,350,2.54282542695918,1.54085162515487 +-133.40018,54.5820766,13.719616,1311425.86137484,712643.793209098,343,350,2.53529412004277,1.51349576878546 +-133.34567,54.5719011,13.719616,1315130.04234687,712643.855620783,342,350,2.53402610605613,1.50888998005878 +-133.2912,54.5616994,13.719616,1318833.53088696,712643.69188773,331,350,2.51982799377572,1.4573183837116 +-133.23675,54.5514715,13.719616,1322537.56291024,712643.697399465,302,251,2.48000694295715,1.31267696107907 +-133.18233,54.5412175,13.719616,1326241.52268531,712643.683490654,165,251,2.21748394421391,0.359118498119706 +-133.12793,54.5309374,13.719616,1329946.03002046,712643.849199691,78,251,1.89209460269048,-0.822788465657962 +-133.07357,54.5206312,13.719616,1333649.85650781,712643.793350221,125,251,2.09691001300806,-0.0788404352462293 +-133.01924,54.5102989,13.719616,1337353.62194492,712643.714436145,192,251,2.28330122870355,0.598185661509398 +-132.96493,54.4999406,13.719616,1341057.94265927,712643.823759258,344,350,2.53655844257153,1.51808814908349 +-132.91066,54.4895562,13.719616,1344761.59367445,712643.706240046,368,350,2.56584781867352,1.62447552310616 +-132.85641,54.4791458,13.719616,1348465.8073603,712643.775678005,374,350,2.57287160220048,1.6499879096635 +-132.80219,54.4687095,13.719616,1352169.9678362,712643.839510566,376,350,2.57518784492766,1.65840116437012 +-132.748,54.4582471,13.719616,1355874.08574923,712643.875427293,375,350,2.57403126772772,1.65420014585993 +-132.69385,54.4477587,13.16228227,1359577.54521663,712643.688092783,359,350,2.55509444857832,1.585416213603 +-158.25564,56.313913,11.54845587,-262774.450804971,708939.793218076,43.2700729370117,20,1.63618762725592,-1.75231564355911 +-158.19581,56.3160249,13.719616,-259070.189104385,708939.772875828,92.8781967163086,120,1.96791377473483,-0.547391591846635 +-158.13598,56.318107,13.719616,-255366.347456664,708939.786708813,72.3935012817383,120,1.85969958160934,-0.940456428684248 +-158.07614,56.3201592,13.719616,-251662.303986428,708939.784726689,44.507453918457,120,1.64843275085876,-1.70783785952736 +-158.01629,56.3221815,13.719616,-247958.05273052,708939.767649941,49.7737121582031,120,1.69700003193759,-1.53142763216692 +-157.95644,56.3241739,13.719616,-244254.204352189,708939.772991909,69.7827911376953,120,1.84374833615619,-0.998395905108827 +-157.89658,56.3261365,11.95162381,-240550.135603137,708939.774739036,18.4777526855469,120,1.26664915002179,-3.09458486965599 +-157.77684,56.3299719,13.3239096,-233141.932403817,708939.76108505,45.611988067627,120,1.65907900203667,-1.66916763650658 +-157.71697,56.3318448,13.719616,-229438.401997285,708939.791814908,154.93310546875,120,2.19014422593367,0.259812837793387 +-157.65708,56.3336877,13.719616,-225734.011999279,708939.763590218,212.042861938477,120,2.32642365725831,0.754818630386808 +-157.59719,56.3355008,13.719616,-222029.988454245,708939.768036713,179.01838684082,120,2.25289763932297,0.48775114683077 +-157.5373,56.3372839,13.719616,-218326.326604481,708939.782040064,69.3122329711914,120,1.84080989035547,-1.00906917897297 +-157.4774,56.3390371,13.719616,-214622.403231453,708939.783589572,66.5818786621094,120,1.82335604496719,-1.07246652724665 +-157.41749,56.3407604,13.719616,-210918.212357042,708939.773543237,111.493537902832,120,2.04724969667144,-0.259220878646278 +-157.35758,56.3424538,13.719616,-207214.364629774,708939.783974689,90.2740325927734,120,1.95556284307647,-0.59225370093667 +-157.29766,56.3441172,13.719616,-203510.237994378,708939.772313486,78.984375,120,1.89754118594313,-0.803004920674694 +-157.23774,56.3457508,13.719616,-199806.441979547,708939.79182246,154.266296386719,120,2.18827105313958,0.253008939548503 +-157.17781,56.3473543,13.719616,-196102.355604353,708939.778795134,171.777160644531,120,2.23496541988269,0.422616207458663 +-157.11787,56.348928,13.719616,-192397.971253564,708939.767576581,148.495544433594,120,2.17171342296681,0.192866900742835 +-157.05794,56.3504717,13.719616,-188694.517254051,708939.79365374,165.693603515625,120,2.21930574311163,0.365735791709403 +-156.99799,56.3519854,13.719616,-184990.13770446,708939.771067445,155.963989257812,120,2.19302433507261,0.270274216251018 +-156.93804,56.3534692,13.719616,-181286.059348974,708939.768195122,137.306701660156,120,2.13769173478225,0.0692904184999278 +-156.87809,56.3549231,13.719616,-177582.276198002,708939.784346017,126.955131530762,120,2.10365025976234,-0.0543579351766961 +-156.81813,56.3563469,13.719616,-173878.166579037,708939.770375789,99.534553527832,121,1.99797387271981,-0.438204735959032 +-156.75817,56.3577409,13.719616,-170174.339678656,708939.786345702,119.567543029785,121,2.07761330510327,-0.148931586185215 +-156.6982,56.3591048,13.719616,-166470.174265038,708939.773110667,93.3001861572266,121,1.96988251027357,-0.540240582436876 +-156.63823,56.3604388,13.719616,-162766.280025856,708939.778502921,168.189987182617,121,2.22580013747394,0.389325285718007 +-156.57825,56.3617428,13.719616,-159062.034770831,708939.766805575,184.09831237793,121,2.26504980736164,0.531891289721269 +-156.51827,56.3630169,13.719616,-155358.048678768,708939.773621365,198.95246887207,121,2.29874933283081,0.654297585027495 +-156.45829,56.3642609,13.719616,-151654.316577938,708939.776066379,214.126937866211,121,2.33067130639175,0.770247304439225 +-156.3983,56.365475,13.719616,-147950.214976388,708939.773571794,210.532073974609,220,2.32331826876583,0.743538973015997 +-156.33831,56.3666591,13.719616,-144246.354895545,708939.777819368,238.696228027344,220,2.37784555616698,0.941597644494287 +-156.27831,56.3678133,13.719616,-140542.113294543,708939.778239996,260.522644042969,220,2.41584547717687,1.07962420385947 +-156.21831,56.3689374,13.719616,-136838.101545265,708939.77428041,271.382904052734,220,2.43358248551452,1.14405008078804 +-156.15831,56.3700315,13.719616,-133134.313222941,708939.776561493,262.458923339844,121,2.41906134293146,1.09130514617962 +-156.0983,56.3710957,13.719616,-129430.125314207,708939.776230295,247.583038330078,121,2.39372088828033,0.999261382000861 +-156.03829,56.3721298,13.719616,-125726.14912788,708939.771100105,233.608749389648,121,2.36848910445272,0.907612341270874 +-155.97828,56.373134,13.719616,-122022.377934655,708939.782982793,218.621612548828,121,2.33969309332607,0.803017009659045 +-155.91826,56.3741081,13.719616,-118318.189745421,708939.771297507,199.206619262695,121,2.29930376511932,0.656311441350092 +-155.85824,56.3750523,13.719616,-114614.194497567,708939.77681687,159.578430175781,121,2.20297418846392,0.30641492373913 +-155.79822,56.3759664,13.719616,-110910.38678814,708939.776802809,101.630683898926,121,2.00702484806742,-0.405329010090951 +-155.73819,56.3768506,13.719616,-107206.143337334,708939.77698276,77.4126052856445,121,1.88881168368378,-0.83471296452868 +-155.67816,56.3777047,13.719616,-103502.075328433,708939.771903784,71.5686492919922,22,1.85472282089468,-0.958533444108833 +-155.61813,56.3785288,13.719616,-99798.1764202584,708939.772315539,73.3563537597656,22,1.86543773622019,-0.919613813305243 +-155.5581,56.3793229,13.719616,-96094.4405729072,708939.777832845,64.2744293212891,22,1.80803822932555,-1.12810520579696 +-155.49806,56.380087,13.719616,-92390.245117844,708939.77417259,57.3616485595703,22,1.75862162435493,-1.30760041995355 +-155.43802,56.3808211,13.719616,-88686.2006419045,708939.77600495,48.2526931762695,22,1.68352155807258,-1.58038529638408 +-155.37798,56.3815252,13.719616,-84982.3011033356,708939.782986718,45.7898330688477,22,1.66076906026912,-1.66302886261569 +-155.31793,56.3821992,13.719616,-81277.9240531307,708939.771399199,44.0905494689941,22,1.64434551116166,-1.72268388072158 +-155.25789,56.3828432,13.719616,-77574.2964629346,708939.777112705,34.1839256286621,22,1.53382193494907,-2.12413705609511 +-155.19784,56.3834572,13.719616,-73870.1790333466,708939.775906545,30.6029930114746,22,1.4857639031091,-2.29869754486579 +-155.13779,56.3840412,13.719616,-70166.1823484666,708939.779732264,25.1338348388672,22,1.40025875688936,-2.60927664153442 +-155.07774,56.3845951,13.719616,-66462.3005449108,708939.777165146,23.50071144104,22,1.37108100994157,-2.71525854660691 +-155.01768,56.385119,13.719616,-62757.9107486944,708939.769647457,21.8753852844238,22,1.33995571085667,-2.8283145169281 +-154.95763,56.3856129,13.719616,-59054.2401705607,708939.776391798,20,22,1.30102999566398,-2.9697038250132 +-154.89757,56.3860768,13.719616,-55350.0495088505,708939.778825042,16,22,1.20411998265592,-3.32170865313004 +-154.83751,56.3865106,13.719616,-51645.9494861714,708939.775027933,31,22,1.49136169383427,-2.27836477118343 +-154.77745,56.3869144,13.35060296,-47941.9338953003,708939.775949504,52,22,1.7160033436348,-1.46240217999747 +-154.71739,56.3872881,13.34238281,-44237.9968099877,708939.770248415,30,22,1.47712125471966,-2.33009011067369 +-154.65733,56.3876319,13.719616,-40534.1319321477,708939.780054657,21,22,1.32221929473392,-2.8927382427631 +-154.59727,56.3879455,13.719616,-36830.3335456279,708939.771749718,20,22,1.30102999566398,-2.9697038250132 +-154.5372,56.3882292,13.719616,-33125.9786436648,708939.773656522,29,22,1.46239799789896,-2.38356918188237 +-154.47714,56.3884828,13.719616,-29422.2946249513,708939.773870795,34.1152572631836,22,1.53294865064333,-2.12730907395371 +-154.41707,56.3887064,13.719616,-25718.042085148,708939.774008197,34.0650634765625,22,1.53230920253698,-2.12963173199262 +-154.35701,56.3889,13.719616,-22014.4482320202,708939.782267032,36.3890953063965,22,1.56097125843526,-2.02552296400482 +-154.29694,56.3890635,13.719616,-18310.2738110436,708939.780216265,40.8214645385742,22,1.61088858170322,-1.84420899807305 +-154.23687,56.3891969,13.719616,-14606.1293714147,708939.771651848,57.0924072265625,22,1.75657835485066,-1.31502215800026 +-154.1768,56.3893004,13.719616,-10902.0087748274,708939.778817441,58.9315872192383,22,1.77034813821502,-1.26500637453344 +-154.11673,56.3893738,13.719616,-7197.90604200632,708939.779358466,51.6416358947754,22,1.71299999131748,-1.47331121285606 +-154.05667,56.3894171,13.719616,-3494.43172186341,708939.773766654,53.3499565124512,22,1.72713406975093,-1.42197220571817 +-153.9966,56.3894304,13.719616,209.653520158344,708939.77156483,69.1626052856445,31,1.8398713443455,-1.01247824596888 +-153.93653,56.3894137,13.719616,3913.73910495099,708939.773830636,67.8463592529297,31,1.83152654766583,-1.04278892935155 +-153.87646,56.389367,13.719616,7617.83108140318,708939.780571906,76.6228637695312,31,1.88435837964996,-0.850888635879009 +-153.81639,56.3892902,13.719616,11321.9355292139,708939.780657393,90.9081268310547,31,1.95860270918587,-0.581212039563167 +-153.75632,56.3891833,13.719616,15026.0585274652,708939.774123087,84.3113327026367,31,1.92588595421464,-0.70004863191025 +-153.69626,56.3890465,13.719616,18729.5894251329,708939.780504871,77.2653503417969,31,1.88798477814825,-0.837716521456063 +-153.63619,56.3888795,13.719616,22433.7676798971,708939.771490517,72.1858673095703,31,1.85845217886799,-0.94498735148502 +-153.57612,56.3886826,13.719616,26137.9825592493,708939.778354681,73.6991348266602,31,1.86746238959293,-0.912259694361835 +-153.51606,56.3884556,13.719616,29841.6236158538,708939.774390091,66.4798355102539,31,1.82268993621111,-1.0748860243751 +-153.45599,56.3881986,13.719616,33545.930092819,708939.779285181,58.4285850524902,31,1.76662536925848,-1.27852853396766 +-153.39593,56.3879115,13.719616,37249.6748836139,708939.772462785,49.564453125,31,1.69517031870349,-1.53807367288532 +-153.33586,56.3875944,13.719616,40954.0972107603,708939.775870251,39.1056861877441,31,1.59223991085913,-1.91194629343939 +-153.2758,56.3872473,13.719616,44657.9698658208,708939.777880213,33.5426292419434,31,1.5255971018155,-2.15401199763732 +-153.21574,56.3868701,13.719616,48361.9156557999,708939.77311169,24.3139572143555,31,1.38585564812741,-2.66159284361435 +-153.15568,56.3864629,13.719616,52065.9405161715,708939.77289367,25.0620899200439,31,1.39901728385277,-2.61378602595498 +-153.09562,56.3860257,13.719616,55770.0504936264,708939.777416651,29.8721714019775,31,1.47526679252786,-2.33682604667053 +-153.03557,56.3855585,13.719616,59473.6350065302,708939.777929676,42.6265563964844,31,1.6296802494097,-1.77595229728716 +-152.97551,56.3850612,13.719616,63177.9335289277,708939.78085261,47.2923851013184,31,1.67479121738233,-1.61209638565841 +-152.91546,56.3845339,13.719616,66881.7186985606,708939.779101557,38.0167694091797,31,1.57997520860049,-1.95649519273731 +-152.85541,56.3839765,13.719616,70585.613380848,708939.770727102,56.7235870361328,31,1.75376368657454,-1.32524583656542 +-152.79536,56.3833892,13.719616,74289.6232462284,708939.778292896,78.6652908325195,31,1.89578315262667,-0.80939059947274 +-152.73531,56.3827718,13.719616,77993.7547335298,708939.779770967,141.674835205078,134,2.15129271614631,0.118693064920753 +-152.67526,56.3821243,13.719616,81698.0139168455,708939.775450613,359.366271972656,134,2.55553731433244,1.58702482842842 +-152.61522,56.3814469,13.719616,85401.7897766764,708939.775076836,644.394409179688,231,2.80915176378793,2.50822489762154 +-152.55518,56.3807395,13.719616,89105.705196215,708939.779559444,607.912414550781,330,2.78384101246792,2.4162890244196 +-152.49514,56.380002,13.719616,92809.7664704286,708939.778079024,418.83984375,330,2.62204798890386,1.82861058250837 +-152.4351,56.3792345,13.719616,96513.9794084633,708939.782130971,91.0174789428711,430,1.95912480198599,-0.579315649493018 +-152.37507,56.378437,13.719616,100217.733423412,708939.776983535,235.046249389648,430,2.37115332558436,0.917289552865439 +-134.1283,54.6801609,12.26850174,1263273.74125482,708939.760059201,544,450,2.73559889969818,2.24105990117004 +-134.07346,54.670335,13.719616,1266978.04503119,708939.858303551,219,251,2.34044411484012,0.805744934160936 +-134.01866,54.6604826,13.719616,1270681.61219269,708939.717157508,233,251,2.36735592102602,0.903496295622358 +-133.96388,54.6506039,13.719616,1274385.67330536,708939.738687388,227,251,2.35602585719312,0.862342269859097 +-133.90913,54.6406988,13.719616,1278089.61892075,708939.720188315,242,251,2.38381536598043,0.963281697690098 +-133.8544,54.6307674,13.719616,1281794.06622887,708939.863997448,238,251,2.37657695705651,0.936989730430824 +-133.79971,54.6208096,13.719616,1285497.78916004,708939.772747402,242,251,2.38381536598043,0.963281697690098 +-133.74504,54.6108255,13.719616,1289202.02150418,708939.842350404,244,251,2.38738982633873,0.976265157963997 +-133.69041,54.6008152,13.719616,1292905.53049918,708939.694446557,260,251,2.41497334797082,1.07645638165265 +-133.6358,54.5907786,13.719616,1296609.5565714,708939.70595669,307,350,2.48713837547719,1.33858035950533 +-133.58122,54.5807157,13.719616,1300313.48692564,708939.681492234,333,350,2.52244423350632,1.4668213131623 +-133.52666,54.5706266,13.719616,1304017.93864179,708939.826752118,360,350,2.55630250076729,1.58980420396575 +-133.47214,54.5605112,13.719616,1307721.68564421,708939.737726319,357,350,2.55266821611219,1.57660344477034 +-133.41764,54.5503697,13.719616,1311425.9582199,708939.827629488,345,350,2.53781909507327,1.52266719879587 +-133.36318,54.540202,13.719616,1315129.53027394,708939.690231221,332,350,2.52113808370404,1.46207700426814 +-133.30874,54.5300082,13.719616,1318833.63543234,708939.730381186,312,251,2.49415459401844,1.36406526787532 +-133.25433,54.5197882,10.86074197,1322537.66423474,708939.738781619,286,251,2.45636603312904,1.22680642879592 +-158.19203,56.2828772,10.91075365,-259070.287690664,705235.783373425,39.7301368713379,20,1.59912006121354,-1.88695562356174 +-158.13225,56.2849575,13.719616,-255366.221285309,705235.782043805,102.997276306152,120,2.01282574023091,-0.384258514013663 +-158.07246,56.2870079,13.719616,-251661.951928361,705235.762403684,170.562881469727,120,2.23188452432954,0.411425515434479 +-158.01267,56.2890285,13.719616,-247958.090171937,705235.773643767,255.229553222656,120,2.40693096024669,1.04724413391261 +-157.95287,56.2910192,13.719616,-244254.013561927,705235.766917595,253.126617431641,120,2.40333781562795,1.03419280707177 +-157.89307,56.29298,13.719616,-240550.333320688,705235.779196345,55.9955291748047,120,1.7481533532165,-1.3456241686704 +-157.83326,56.294911,13.46419264,-236846.425654209,705235.785039923,51.6053504943848,120,1.71269473204817,-1.47442000165189 +-157.77344,56.2968122,13.719616,-233142.284626106,705235.785227333,63.643985748291,120,1.80375736981624,-1.14365450941371 +-157.71361,56.2986834,13.66294693,-229437.905545047,705235.758282282,73.5534286499023,120,1.86660292191776,-0.915381526274578 +-157.65379,56.3005248,13.719616,-225734.515556484,705235.795258702,105.01131439209,120,2.02123609443494,-0.353709706990567 +-157.59395,56.3023363,13.719616,-222030.257765605,705235.782196471,95.9390258789062,120,1.98199530452426,-0.4962434563827 +-157.53411,56.3041179,13.719616,-218326.36057154,705235.787350921,106.543411254883,120,2.02752659769994,-0.330860803643701 +-157.47426,56.3058696,13.719616,-214622.200814806,705235.777577449,160.585601806641,120,2.20570660360615,0.316339835444666 +-157.41441,56.3075914,13.719616,-210918.389705996,705235.785495234,89.8599853515625,120,1.95356634346092,-0.599505557398071 +-157.35455,56.3092833,13.719616,-207214.304082866,705235.779102704,112.925834655762,120,2.05279330919626,-0.239084895651608 +-157.29468,56.3109453,13.719616,-203509.937967569,705235.759287076,126.808975219727,120,2.10314999290263,-0.0561750472015681 +-157.23481,56.3125774,13.719616,-199805.902566673,705235.757035636,148.832443237305,120,2.17269761120401,0.196441753335638 +-157.17494,56.3141796,13.719616,-196102.191899715,705235.77158992,173.150726318359,120,2.23842431763191,0.435179911351518 +-157.11506,56.3157519,13.719616,-192398.182799221,705235.77323453,170.416442871094,120,2.23151149596862,0.41007056995471 +-157.05518,56.3172943,13.719616,-188694.486467941,705235.791324925,144.792663574219,120,2.16074655737251,0.153032114649266 +-156.99529,56.3188067,13.719616,-184990.480238749,705235.786147867,109.122291564941,120,2.03791347757962,-0.293132691209994 +-156.93539,56.3202892,13.719616,-181286.157603317,705235.769813307,120.231666564941,120,2.08001886702759,-0.140193898660321 +-156.87549,56.3217418,13.719616,-177582.129760786,705235.770044985,120.77742767334,121,2.08198577573454,-0.133049524825063 +-156.81559,56.3231645,13.719616,-173878.390723404,705235.786167375,108.050048828125,121,2.03362496747822,-0.308709783960951 +-156.75568,56.3245572,13.719616,-170174.317779179,705235.780751731,97.5526428222656,21,1.98923903946687,-0.469932143503327 +-156.69576,56.32592,13.719616,-166469.904455387,705235.765965253,98.4023513793945,21,1.99300547626564,-0.456251370002108 +-156.63585,56.3272528,13.719616,-162766.379574945,705235.780721428,163.158416748047,121,2.2126094823712,0.341413061397063 +-156.57593,56.3285557,13.719616,-159062.502311606,705235.785967318,178.259475708008,121,2.2510526248539,0.481049527659517 +-156.516,56.3298287,13.719616,-155358.266672191,705235.782769885,206.390121459961,121,2.31468890662718,0.712194666663233 +-156.45607,56.3310717,13.719616,-151654.284260591,705235.783900924,223.574111938477,220,2.34942151436122,0.838353411626505 +-156.39613,56.3322847,13.719616,-147949.931865704,705235.766502826,229.960418701172,220,2.36165309071773,0.882781988192833 +-156.3362,56.3334678,13.719616,-144246.437440436,705235.786268953,253.305725097656,220,2.40364500562246,1.03530860881258 +-156.27625,56.3346209,13.719616,-140541.943812647,705235.766342118,282.369537353516,220,2.45081784226336,1.2066538159604 +-156.21631,56.3357441,13.719616,-136838.296139221,705235.782491256,267.967193603516,220,2.42808162795015,1.12406939601318 +-156.15636,56.3368373,13.719616,-133134.254411815,705235.78127967,257.084625244141,121,2.4100761047592,1.0586681964957 +-156.09641,56.3379005,13.719616,-129430.429786173,705235.783359797,242.642593383789,121,2.38496703910219,0.96746490318855 +-156.03645,56.3389338,13.719616,-125726.19870379,705235.780451208,228.03630065918,121,2.35800398700524,0.869527401951158 +-155.97649,56.339937,13.719616,-122022.173012651,705235.76982464,213.397094726562,121,2.32918850246984,0.764861337360471 +-155.91653,56.3409104,13.719616,-118318.345684676,705235.784454503,187.49853515625,121,2.27299787912484,0.560760954970782 +-155.85656,56.3418537,13.719616,-114614.094496465,705235.773185581,140.73974609375,121,2.14841676318859,0.108246782899611 +-155.79659,56.3427671,13.719616,-110910.029966193,705235.776247347,85.6292343139648,121,1.93262206063154,-0.675581170727887 +-155.73662,56.3436504,13.719616,-107206.146672502,705235.770916864,70.4830017089844,121,1.84808439140128,-0.982646114825283 +-155.67665,56.3445038,13.719616,-103502.437986652,705235.779078912,67.8687973022461,22,1.83167015316044,-1.04226731320604 +-155.61667,56.3453272,13.719616,-99798.2809884107,705235.774159281,68.2158432006836,22,1.83388525171741,-1.03422144299503 +-155.55669,56.3461207,13.719616,-96094.2865652934,705235.783065868,60.7609786987305,22,1.78362476058303,-1.21678189256753 +-155.49671,56.3468841,13.719616,-92390.4492126908,705235.783129443,55.6446075439453,22,1.74542308372228,-1.3555412867699 +-155.43672,56.3476175,13.719616,-88686.1454353131,705235.771788634,50.0050468444824,22,1.69901383845801,-1.52411291208713 +-155.37673,56.348321,13.719616,-84981.986149035,705235.774320789,47.9003639221191,22,1.6803388129713,-1.59194593503782 +-155.31674,56.3489944,13.719616,-81277.9657870425,705235.76809719,36.1905784606934,22,1.55859552481252,-2.03415230662451 +-155.25675,56.3496379,13.719616,-77574.0778572435,705235.775103936,35.5999908447266,22,1.55144988628509,-2.06010730532443 +-155.19676,56.3502513,13.719616,-73870.3167514661,705235.772739468,30.4674758911133,22,1.48383647614692,-2.30569850973486 +-155.13676,56.3508348,13.719616,-70166.0588311517,705235.772453237,28.5909328460693,22,1.45622832546261,-2.40597919317101 +-155.07676,56.3513883,13.719616,-66461.9154517814,705235.774503004,25.5543975830078,22,1.4074656473942,-2.58309915816948 +-155.01677,56.3519117,13.719616,-62758.4979280887,705235.77692882,26.0217609405518,22,1.41533668272854,-2.554509311218 +-154.95676,56.3524052,13.719616,-59053.9483091291,705235.773438792,20,22,1.30102999566398,-2.9697038250132 +-154.89676,56.3528686,13.719616,-55350.1124409444,705235.769849437,18,22,1.25527250510331,-3.13590809121766 +-154.83676,56.3533021,13.719616,-51646.3667835834,705235.778797449,17,22,1.23044892137827,-3.22607443266317 +-154.77675,56.3537055,13.719616,-47942.0883990999,705235.770557846,14,22,1.14612803567824,-3.53235195710261 +-154.71675,56.354079,13.719616,-44238.5053443682,705235.782241611,20,22,1.30102999566398,-2.9697038250132 +-154.65674,56.3544224,13.719616,-40534.3774547617,705235.77749001,26,22,1.41497334797082,-2.55582904676412 +-154.59673,56.3547358,13.719616,-36830.3157413365,705235.774513523,23,22,1.36172783601759,-2.74923194396041 +-154.53672,56.3550192,13.719616,-33126.3141595899,705235.77316571,40,22,1.60205999132796,-1.87627695824656 +-154.47671,56.3552726,13.719616,-29422.3666647852,705235.773314146,49.3739624023438,22,1.69349798199813,-1.54414807713159 +-154.4167,56.355496,13.719616,-25718.4672119709,705235.77484042,53.8408737182617,22,1.7311120989117,-1.40752286836366 +-154.35668,56.3556894,13.719616,-22013.9925702704,705235.7743253,59.5143394470215,22,1.77462161770198,-1.2494838772643 +-154.29667,56.3558528,13.719616,-18310.1710658487,705235.778865819,75.5232772827148,22,1.878080827621,-0.873690496639928 +-154.23666,56.3559861,13.719616,-14606.3795072646,705235.773360443,75.6247253417969,22,1.87866381036785,-0.871572936903547 +-154.17664,56.3560895,13.719616,-10901.9945736508,705235.778410435,80.1971969604492,22,1.90415918915843,-0.778966444030536 +-154.11663,56.3561628,13.719616,-7198.24466022825,705235.775503179,81.1443099975586,22,1.9092580716262,-0.760445847541678 +-154.05662,56.3562061,13.719616,-3494.50649578848,705235.773557722,79.6435089111328,22,1.90115038580003,-0.789895276626259 +-153.9966,56.3562194,13.719616,209.84315118638,705235.772585378,67.2178802490234,31,1.82748481264599,-1.05746966456964 +-153.93659,56.3562027,13.719616,3913.57595501931,705235.773074509,93.5408630371094,31,1.971001372527,-0.536176555377339 +-153.87657,56.356156,13.719616,7617.93233298325,705235.775653827,92.5127258300781,31,1.96620147736216,-0.553611144642511 +-153.81656,56.3560793,13.719616,11321.683959375,705235.778608776,85.5563583374023,31,1.93225229077058,-0.676924280405714 +-153.75654,56.3559725,13.719616,15026.0712922804,705235.773674449,78.0415420532227,31,1.89232584220107,-0.821948537753185 +-153.69653,56.3558358,13.719616,18729.8659341835,705235.779238646,72.6488265991211,31,1.86122860410352,-0.934902582558906 +-153.63652,56.355669,13.719616,22433.6912082235,705235.774764888,68.4519348144531,31,1.83538572810719,-1.02877128446876 +-153.57651,56.3554722,13.719616,26137.553118947,705235.771483756,65.1913375854492,31,1.8141898919164,-1.10576061140769 +-153.51649,56.3552454,13.719616,29842.074897384,705235.773980683,64.1805114746094,31,1.80740317380211,-1.130411908721 +-153.45648,56.3549886,13.719616,33546.0282171786,705235.77393239,58.8762435913086,31,1.76994009345566,-1.26648850956699 +-153.39647,56.3547018,13.719616,37250.0363089966,705235.775394655,52.9644432067871,31,1.72398441108511,-1.43341266499451 +-153.33647,56.354385,13.719616,40953.488031812,705235.772334754,42.7108535766602,31,1.63053825089133,-1.77283579100786 +-153.27646,56.3540382,13.719616,44657.6238015753,705235.776676422,37.8099937438965,31,1.57760660550346,-1.96509863525233 +-153.21645,56.3536613,13.719616,48361.832608335,705235.771820823,33.9435386657715,31,1.5307571162052,-2.13526935255919 +-153.15645,56.3532545,13.719616,52065.5030571954,705235.772408027,39.8137397766113,31,1.60003297356659,-1.88363966532432 +-153.09644,56.3528177,13.719616,55769.8756847416,705235.78259818,48.6304893493652,31,1.68690863972363,-1.56808244905811 +-153.03644,56.3523508,13.719616,59473.7223245869,705235.775206315,56.615047454834,31,1.75293187567708,-1.32826721116747 +-152.97644,56.3518539,13.719616,63177.6660637227,705235.769442231,58.9629058837891,31,1.77057887882311,-1.26416825878491 +-152.91644,56.3513271,13.719616,66881.7127627256,705235.776689212,69.6974029541016,31,1.84321659583522,-1.00032733772836 +-152.85644,56.3507702,13.719616,70585.8688175634,705235.7748909,85.3161087036133,31,1.93103103891185,-0.681360215736588 +-152.79645,56.3501834,13.719616,74289.5227102056,705235.775423196,102.001953125,134,2.00860848767652,-0.39957677901496 +-152.73645,56.3495665,13.719616,77993.9152475058,705235.778073406,143.075180053711,134,2.15556430112094,0.134208680780356 +-152.67646,56.3489196,13.719616,81697.8179067214,705235.77135022,617.998291015625,231,2.79098727411226,2.442246286458 +-152.4965,56.3467991,13.719616,92809.7324395756,705235.773473992,627.128112792969,430,2.79735626969131,2.46538029629341 +-152.43652,56.3460323,13.719616,96513.587258227,705235.773222295,308.053100585938,430,2.48862558436977,1.34398232669487 +-152.37654,56.3452355,13.719616,100217.599560207,705235.775318095,548.202941894531,430,2.73894136182211,2.25320067763782 +-134.09041,54.6385311,13.719616,1266977.86565281,705235.797081975,380,351,2.57978359661681,1.67509424626323 +-134.03565,54.6286864,13.719616,1270681.48351367,705235.679039843,248,251,2.39445168082622,1.0019158291165 +-133.98091,54.6188153,13.719616,1274385.59544907,705235.710177274,226,251,2.3541084391474,0.855377660231438 +-133.9262,54.6089179,13.719616,1278089.58485218,705235.709034042,227,251,2.35602585719312,0.862342269859097 +-133.87151,54.5989942,13.719616,1281794.07276825,705235.867314182,241,251,2.38201704257487,0.956749673788491 +-133.81686,54.5890441,13.719616,1285497.83200932,705235.787643632,245,251,2.38916608436453,0.982717034108231 +-133.76223,54.5790677,13.719616,1289202.09748376,705235.865928588,231,251,2.36361197989214,0.889897232796936 +-133.70764,54.5690651,13.719616,1292905.63531699,705235.723803126,261,251,2.41664050733828,1.08251198032994 +-133.65307,54.5590362,13.719616,1296609.68704807,705235.738181409,284,251,2.45331834004704,1.21573633762386 +-133.59853,54.5489811,13.719616,1300313.63596015,705235.724272324,303,350,2.4814426285023,1.31789178076452 +-133.54402,54.5388998,13.719616,1304017.48585487,705235.680803597,350,350,2.54406804435028,1.54536516619764 +-133.48953,54.5287922,13.719616,1307721.86109556,705235.792825006,335,350,2.52504480703685,1.47626733850276 +-133.43508,54.5186585,13.719616,1311425.52434778,705235.687007984,318,350,2.50242711998443,1.39411344339779 +-133.38065,54.5084986,13.719616,1315129.71714132,705235.745883934,308,251,2.48855071650044,1.34371038522406 +-133.32625,54.4983126,10.84855305,1318833.82266358,705235.781883511,271,251,2.43296929087441,1.14182278283197 +-158.24797,56.2476197,11.04085681,-262774.053409795,701531.768228161,64.5446090698242,20,1.80985997473569,-1.12148810648942 +-158.18825,56.249728,13.20831979,-259069.96661219,701531.762460915,98.2288970947266,20,1.99223926785454,-0.459034457648887 +-158.12853,56.2518065,12.1993645,-255366.298720818,701531.784753506,65.8634872436523,120,1.81864472137408,-1.08957939928245 +-158.0688,56.2538551,13.719616,-251662.426749336,701531.7851203,67.4206695556641,120,1.82879306119128,-1.05271773244184 +-158.00906,56.255874,13.719616,-247958.343394932,701531.786547617,96.2098388671875,120,1.98321948728972,-0.49179687516198 +-157.94931,56.257863,13.719616,-244254.044084311,701531.767513873,189.360961914062,120,2.27729045105172,0.576352801431208 +-157.88956,56.2598222,13.719616,-240550.139947771,701531.776124358,172.378082275391,120,2.23648204482989,0.428125022154728 +-157.8298,56.2617515,13.719616,-236846.007952617,701531.764676424,123.964241027832,120,2.09329642577536,-0.0919660154958554 +-157.77004,56.263651,13.61675101,-233142.259246105,701531.780188447,81.2805862426758,120,1.90998682733454,-0.757798798801381 +-157.71027,56.2655206,12.91235439,-229438.270772494,701531.77609941,94.0009689331055,120,1.97313233019685,-0.528436308884564 +-157.65049,56.2673604,13.719616,-225734.03595262,701531.764350358,95.6789779663086,120,1.980816527577,-0.500525110711587 +-157.59071,56.2691704,13.719616,-222030.166592083,701531.779195809,134.699295043945,120,2.12936532282524,0.0390465136774961 +-157.53092,56.2709504,13.719616,-218326.040193348,701531.764651487,138.693115234375,120,2.14205490310694,0.0851386912274364 +-157.47113,56.2727006,13.719616,-214622.267333834,701531.776153184,173.718872070312,120,2.23984700089265,0.440347503028752 +-157.41133,56.274421,13.719616,-210918.224327977,701531.781131111,135.832748413086,120,2.1330044882102,0.0522650010768758 +-157.35152,56.2761114,13.719616,-207213.906357412,701531.758187054,126.33422088623,120,2.10152100636692,-0.0620919912583073 +-157.29171,56.277772,13.719616,-203509.924055634,701531.761128093,122.35572052002,120,2.08762427881409,-0.112568872251124 +-157.2319,56.2794027,13.719616,-199806.272019025,701531.778046659,137.326293945312,120,2.13775369981545,0.0695154931871016 +-157.17208,56.2810035,13.719616,-196102.326526631,701531.778657282,146.439575195312,120,2.16565846037202,0.170873548340182 +-157.11225,56.2825745,13.719616,-192398.081077283,701531.775029508,123.265235900879,120,2.09084061118441,-0.100886235049483 +-157.05242,56.2841155,13.719616,-188694.148489332,701531.774241795,103.389358520508,120,2.01447584075354,-0.378264877929906 +-156.99258,56.2856266,13.719616,-184989.904505625,701531.758862257,107.806098937988,21,2.03264333098234,-0.312275367900932 +-156.93274,56.2871079,13.719616,-181285.960394914,701531.768300792,100.139953613281,21,2.00060738588953,-0.428639064447118 +-156.8729,56.2885592,13.719616,-177582.31116825,701531.779588097,84.8586807250977,21,1.92869627562452,-0.689840742403984 +-156.81305,56.2899806,13.719616,-173878.332595065,701531.777008353,100.311042785645,21,2.00134874515288,-0.425946235997632 +-156.75319,56.2913722,13.719616,-170174.018227282,701531.77271666,81.0682601928711,21,1.908850852717,-0.761924982851728 +-156.69333,56.2927338,13.719616,-166469.980755811,701531.770522289,107.972038269043,121,2.0333112999522,-0.309849113945065 +-156.63347,56.2940655,13.719616,-162766.213720345,701531.78093434,157.329864501953,121,2.19681116863306,0.284029076612472 +-156.5736,56.2953672,13.719616,-159062.093820336,701531.768239258,185.483474731445,121,2.26830522310126,0.543715888875753 +-156.51373,56.2966391,13.719616,-155358.231934931,701531.779185284,207.718948364258,220,2.31747611519032,0.722318603713095 +-156.45385,56.297881,13.719616,-151654.005183534,701531.76805812,226.334548950195,220,2.35475085211288,0.857711087484958 +-156.39397,56.299093,13.719616,-147950.024885391,701531.769375102,236.951019287109,220,2.37465858123468,0.930021641886962 +-156.33409,56.3002751,13.719616,-144246.285047362,701531.782572774,263.50927734375,220,2.42079590997843,1.09760558878897 +-156.2742,56.3014272,13.719616,-140542.1623137,701531.774793588,274.761810302734,220,2.43895636911762,1.1635695598936 +-156.21431,56.3025494,13.719616,-136838.268030961,701531.778924469,264.659149169922,220,2.42268691198808,1.10447424783373 +-156.15441,56.3036416,13.719616,-133133.978821478,701531.763250405,254.016540527344,121,2.40486199703675,1.03972906899321 +-156.09451,56.304704,13.719616,-129429.905698476,701531.770717779,239.391265869141,121,2.37910830123316,0.946184294997986 +-156.03461,56.3057363,13.719616,-125726.04371931,701531.767393073,222.856292724609,121,2.34802490163507,0.83328051557218 +-155.97471,56.3067388,13.719616,-122022.385830546,701531.786235479,206.788330078125,121,2.31552602607722,0.715235323443458 +-155.9148,56.3077112,13.719616,-118318.309284114,701531.775521275,180.33122253418,121,2.2560709269463,0.499277433225141 +-155.85489,56.3086538,13.719616,-114614.424828793,701531.787170875,116.776992797852,121,2.0673572872527,-0.186184370377411 +-155.79497,56.3095663,13.719616,-110910.109654644,701531.770602023,79.2785568237305,121,1.89915573571038,-0.797140415081668 +-155.73505,56.3104489,13.719616,-107205.974860622,701531.765501004,70.9470977783203,22,1.85093463454134,-0.972293218200184 +-155.67513,56.3113016,13.719616,-103502.014444498,701531.771457077,70.1905975341797,22,1.84627893958692,-0.98920403114229 +-155.61521,56.3121243,13.719616,-99798.2226745669,701531.77692461,67.3837814331055,22,1.82855537900263,-1.05358106199224 +-155.55528,56.312917,13.719616,-96093.9757735939,701531.76705033,63.6690826416016,22,1.80392859249679,-1.14303257976617 +-155.49536,56.3136798,13.719616,-92390.502943049,701531.782110774,57.9217834472656,22,1.76284192558864,-1.29227108127884 +-155.43542,56.3144126,13.719616,-88685.9451887022,701531.76886572,50.2882957458496,22,1.70146691777017,-1.51520262784685 +-155.37549,56.3151155,13.719616,-84982.1494744115,701531.779858733,46.5633125305176,22,1.66804386860386,-1.63660468230688 +-155.31556,56.3157883,13.719616,-81278.4924925177,701531.77855081,33.8606910705566,22,1.52969581747837,-2.13912429245985 +-155.25562,56.3164312,13.719616,-77574.3500109592,701531.775246826,36.0297698974609,22,1.55666148852884,-2.04117727843575 +-155.19568,56.3170442,13.719616,-73870.3337661625,701531.782443895,30.4013805389404,22,1.48289330554397,-2.30912437457248 +-155.13574,56.3176271,13.719616,-70166.4381320011,701531.777555501,28.7515907287598,22,1.45866187774256,-2.39713983668527 +-155.07579,56.3181801,13.719616,-66462.0389353036,701531.772602836,26.8451900482178,22,1.42886648286063,-2.50536521534882 +-155.01585,56.3187031,13.719616,-62758.3658251304,701531.77675068,25.2960567474365,22,1.40305282685564,-2.5991277819099 +-154.9559,56.3191961,13.719616,-59054.1772754433,701531.77029732,24,22,1.38021124171161,-2.68209493879053 +-154.89595,56.3196592,13.719616,-55350.0848397705,701531.774171599,22,22,1.34242268082221,-2.81935377786993 +-154.836,56.3200923,13.719616,-51646.0826488284,701531.777006512,20,22,1.30102999566398,-2.9697038250132 +-154.77605,56.3204954,13.719616,-47942.1646623831,701531.778599962,24,22,1.38021124171161,-2.68209493879053 +-154.7161,56.3208685,13.719616,-44238.3248398822,701531.778763821,20,22,1.30102999566398,-2.9697038250132 +-154.65614,56.3212116,13.719616,-40533.9393969766,701531.771220427,25,22,1.39794000867204,-2.61769899689636 +-154.59619,56.3215248,13.719616,-36830.2376793556,701531.779726235,41,22,1.61278385671974,-1.83732481824772 +-154.53623,56.3218079,13.719616,-33125.9783689508,701531.770182294,56,22,1.7481880270062,-1.34549822356933 +-154.47628,56.3220611,13.719616,-29422.3907209079,701531.775293956,66.4054107666016,22,1.82220346747556,-1.07665301767462 +-154.41632,56.3222843,13.719616,-25718.2333065246,701531.774372879,73.4668273925781,22,1.86609128558214,-0.917239935481098 +-154.35636,56.3224775,13.719616,-22014.1178272267,701531.772302943,91.0556488037109,22,1.95930689321917,-0.578654242160078 +-154.2964,56.3226408,13.719616,-18310.0381910283,701531.780146111,95.9409027099609,22,1.98200380043497,-0.496212596810013 +-154.23644,56.322774,13.719616,-14605.9884651854,701531.775521964,90.4229125976562,22,1.95627849191214,-0.589654260099007 +-154.17648,56.3228773,13.719616,-10901.9625177484,701531.780672595,93.1145248413086,122,1.96901743142615,-0.543382795728796 +-154.11652,56.3229505,13.719616,-7197.95437548805,701531.773245443,100.680328369141,122,2.00294462333116,-0.420149550945106 +-154.05656,56.3229938,13.719616,-3493.95794656153,701531.775510761,103.813499450684,122,2.01625383092806,-0.371806710127117 +-153.9966,56.3230071,13.719616,210.032782076689,701531.776296111,115.294715881348,31,2.06180940342514,-0.206335867962798 +-153.93664,56.3229904,13.719616,3914.0238531352,701531.775595303,106.533805847168,31,2.027487442171,-0.331003027700895 +-153.87668,56.3229437,13.719616,7618.02130932129,701531.773416107,95.05322265625,31,1.97796684564229,-0.51087596887864 +-153.81672,56.3228671,13.719616,11322.0311625345,701531.780932564,81.2979507446289,31,1.91007959858895,-0.757461827125825 +-153.75676,56.3227604,13.719616,15026.0595068948,701531.775875974,80.8690185546875,31,1.90778217244325,-0.765806734637707 +-153.69681,56.3226238,13.719616,18729.4945698614,701531.777780257,74.7460708618164,31,1.87358836826228,-0.890008391306393 +-153.63685,56.3224571,13.719616,22433.5779726077,701531.769487686,70.5606307983398,31,1.84856245464947,-0.980909652655016 +-153.57689,56.3222605,13.719616,26137.6979021052,701531.771117722,67.9035034179688,31,1.83189218187756,-1.04146084153214 +-153.51693,56.3220339,13.719616,29841.8604514625,701531.771610001,65.7876739501953,31,1.81814453135154,-1.09139623221279 +-153.45697,56.3217774,13.719616,33546.0715715222,701531.78222218,66.2227020263672,31,1.82100689691138,-1.08099930349897 +-153.39702,56.3214908,13.719616,37249.7197329581,701531.775161166,59.7431831359863,31,1.77628835823405,-1.24342979991671 +-153.33706,56.3211743,13.719616,40954.0462718957,701531.78352461,54.4879913330078,31,1.73630079819462,-1.38867603156587 +-153.27711,56.3208277,13.719616,44657.8219553489,701531.773381076,56.0291786193848,31,1.7484142558125,-1.34467649597272 +-153.21716,56.3204512,13.719616,48361.6703351987,701531.772804533,67.4348068237305,31,1.82888411774601,-1.05238698904492 +-153.15721,56.3200447,13.719616,52065.597563602,701531.770819031,168.568481445312,31,2.22677637447612,0.392871257155711 +-153.09726,56.3196083,13.719616,55769.6095294918,701531.778765426,144.037445068359,134,2.1584754092658,0.144782656475471 +-153.03731,56.3191418,13.719616,59473.7125661698,701531.774544917,118.055221557617,134,2.07208520059314,-0.169011239644107 +-152.97736,56.3186454,13.719616,63177.9124002187,701531.7806774,107.466415405273,134,2.03127276301422,-0.317253661960189 +-152.91742,56.318119,13.719616,66881.5974792054,701531.776172436,80.0043334960938,31,1.90311351152281,-0.782764643669225 +-152.85747,56.3175626,13.719616,70586.0093291214,701531.780859679,103.13761138916,134,2.01341706916378,-0.382110638547417 +-152.79753,56.3169762,13.719616,74289.9185016293,701531.774299231,177.04133605957,134,2.24807467837689,0.470232776064488 +-152.73759,56.3163599,13.719616,77993.9485663827,701531.777985733,253.202133178711,231,2.40346736020725,1.03466334995949 +-152.67766,56.3157136,13.719616,81697.4880094426,701531.768754351,653.638793945312,330,2.81533781998764,2.53069441941513 +-134.0526,54.5968861,13.719616,1270682.09660862,701531.870823199,307,351,2.48713837547719,1.33858035950533 +-133.99791,54.5870227,13.719616,1274385.63467963,701531.731444672,247,251,2.39269695325967,0.995542157745674 +-133.94324,54.5771329,13.719616,1278089.66753463,701531.737620365,225,251,2.35218251811136,0.848382165315956 +-133.8886,54.5672168,13.719616,1281793.57799802,701531.707330411,252,251,2.40140054078154,1.02715607187634 +-133.83398,54.5572744,13.719616,1285497.98766754,701531.832837249,263,251,2.41995574848976,1.09455388245613 +-133.7794,54.5473058,13.719616,1289201.66157009,701531.736880438,252,251,2.40140054078154,1.02715607187634 +-133.72484,54.5373109,13.719616,1292905.84235403,701531.795242161,252,251,2.40140054078154,1.02715607187634 +-133.67031,54.5272897,13.719616,1296609.91611422,701531.81307198,260,251,2.41497334797082,1.07645638165265 +-133.61581,54.5172423,13.719616,1300313.88332261,701531.799697359,275,251,2.43933269383026,1.16493647866368 +-133.56134,54.5071688,13.719616,1304017.74441125,701531.764440938,268,251,2.42813479402879,1.12426251038591 +-133.5069,54.497069,13.719616,1307721.50990735,701531.68482545,288,251,2.45939248775923,1.23779937584891 +-133.45248,54.4869431,13.719616,1311425.79459748,701531.778256397,287,251,2.45788189673399,1.23231247807964 +-133.39809,54.476791,10.68159105,1315129.98789368,701531.836518735,290,251,2.46239799789896,1.24871624653439 +-158.24415,56.2144708,11.56204133,-262774.143475952,697827.768411518,80.5943908691406,20,1.90630481724742,-0.771172910388113 +-158.12481,56.218654,12.8707423,-255365.963074025,697827.757331255,61.5073432922363,20,1.78892696879843,-1.19752275892831 +-158.06514,56.2207009,13.719616,-251662.494450962,697827.789162298,116.492866516113,120,2.06629933199258,-0.190027165852645 +-158.00545,56.222718,13.719616,-247958.19571215,697827.769968956,132.212051391602,120,2.12127104376026,0.0096457817762164 +-157.94576,56.2247053,13.719616,-244254.2975341,697827.775724452,169.100341796875,120,2.22814448542357,0.397840626614586 +-157.88606,56.2266628,13.719616,-240550.175688112,697827.769289457,116.024070739746,120,2.06454809875263,-0.19638814483187 +-157.82636,56.2285905,13.719616,-236846.442546379,697827.787096588,98.9984970092773,120,1.99562860120834,-0.446723431495829 +-157.76665,56.2304884,13.719616,-233142.473877153,697827.793149229,88.1850662231445,120,1.94539504538113,-0.629186044344555 +-157.70693,56.2323564,13.719616,-229438.264370514,697827.777109905,86.2308731079102,120,1.93566278345687,-0.664536397517595 +-157.64721,56.2341946,13.719616,-225734.42575205,697827.784911433,119.90013885498,120,2.07881968605062,-0.144549666249034 +-157.58748,56.236003,13.719616,-222030.333785604,697827.782271385,150.541961669922,120,2.17765757090426,0.214457742680379 +-157.52774,56.2377815,13.719616,-218325.983126873,697827.758891568,158.943267822266,120,2.20124213772698,0.300123621086092 +-157.468,56.2395302,13.719616,-214621.985527209,697827.759074311,154.690963745117,120,2.18946494517802,0.257345496202844 +-157.40826,56.2412491,13.719616,-210918.335047467,697827.782010948,136.978637695312,120,2.13665284267144,0.0655168658241178 +-157.34851,56.2429381,13.719616,-207214.40800794,697827.784567718,145.927169799805,120,2.1641361595808,0.16534411735856 +-157.28875,56.2445973,13.719616,-203510.197884748,697827.778772466,128.762130737305,120,2.10978815471595,-0.0320633487755709 +-157.22899,56.2462266,13.719616,-199806.317577936,697827.784479055,119.536666870117,120,2.0775011419101,-0.149338994917351 +-157.16922,56.247826,13.719616,-196102.142811792,697827.771403523,117.904769897461,120,2.07153137505474,-0.171022892077109 +-157.10945,56.2493956,13.719616,-192398.28538985,697827.780587274,103.904083251953,120,2.01663261491951,-0.370430858554462 +-157.04967,56.2509353,13.719616,-188694.121575856,697827.771751285,93.8153839111328,21,1.97227406012635,-0.531553790755284 +-156.98989,56.2524451,13.719616,-184990.263692805,697827.773709936,97.8691101074219,21,1.99064563943571,-0.464822970932894 +-156.9301,56.2539251,13.719616,-181286.086968211,697827.769605759,93.9440231323242,21,1.97286915481205,-0.529392236999877 +-156.87031,56.2553752,13.719616,-177582.20423459,697827.77602564,88.9089736938477,21,1.94894559706738,-0.616289427191758 +-156.81051,56.2567954,13.719616,-173877.991208982,697827.766114669,82.5624008178711,21,1.91678231324139,-0.733115654362913 +-156.75071,56.2581857,13.719616,-170174.060209724,697827.76651138,76.3111419677734,21,1.882587952658,-0.857319332044006 +-156.69091,56.2595462,13.719616,-166470.404801115,697827.78771279,104.624961853027,121,2.01963531265462,-0.359524203325275 +-156.6311,56.2608767,13.719616,-162766.401610347,697827.782294479,155.063873291016,121,2.19051062787227,0.261143714215912 +-156.57128,56.2621774,13.719616,-159062.043757898,697827.773596949,186.475662231445,121,2.27062215813769,0.552131658247165 +-156.51146,56.2634481,13.719616,-155357.944431159,697827.763797264,209.629043579102,121,2.32145145289335,0.736758164924842 +-156.45164,56.264689,13.719616,-151654.096788703,697827.774591961,224.051773071289,220,2.35034838512489,0.841720070795424 +-156.39182,56.2658999,13.719616,-147950.495674559,697827.783117538,244.869873046875,220,2.38893535607472,0.981878963103237 +-156.33199,56.267081,13.719616,-144246.515984283,697827.78937953,276.308013916016,220,2.44139348118517,1.17242184654399 +-156.27215,56.2682321,13.719616,-140542.152519847,697827.772213755,270.534851074219,220,2.43222322010533,1.1391128408489 +-156.21231,56.2693533,13.719616,-136838.017188945,697827.76450777,261.086456298828,220,2.41678434364507,1.08303443485117 +-156.15247,56.2704447,13.719616,-133134.103637331,697827.776886419,251.296356201172,220,2.40018619136537,1.02274520818696 +-156.09263,56.2715061,13.719616,-129430.406604048,697827.786551685,237.341217041016,220,2.37537316501499,0.932617214139577 +-156.03278,56.2725375,13.719616,-125726.301763156,697827.774077912,223.551559448242,121,2.34937770376077,0.838194279020876 +-155.97293,56.2735391,13.719616,-122022.400727836,697827.78132521,208.465087890625,121,2.31903333314191,0.727974863787513 +-155.91307,56.2745107,13.719616,-118318.07987318,697827.767719114,168.10400390625,121,2.22557805760177,0.388518628234385 +-155.85321,56.2754525,13.719616,-114613.950850972,697827.774033258,95.4132614135742,121,1.97960874114513,-0.504912135768694 +-155.79335,56.2763642,13.719616,-110910.008596905,697827.766388132,72.907341003418,121,1.86277125941213,-0.929299218160388 +-155.73349,56.2772461,13.719616,-107206.24617905,697827.777801787,67.4632949829102,22,1.82906754880026,-1.05172071509946 +-155.67362,56.278098,13.719616,-103502.03988916,697827.769983833,66.927619934082,22,1.82560538098925,-1.06429629679011 +-155.61375,56.27892,13.719616,-99798.0017274764,697827.770386377,60.3553276062012,22,1.78071561159747,-1.22734875203685 +-155.55388,56.2797121,13.719616,-96094.125693464,697827.778627287,63.230884552002,22,1.80092925730533,-1.15392702127702 +-155.49401,56.2804742,13.719616,-92390.4060368094,697827.783189448,53.6758232116699,22,1.72977871381707,-1.41236610361336 +-155.43413,56.2812064,13.719616,-88686.218183563,697827.781512755,50.4676170349121,22,1.70301279882877,-1.50958754660359 +-155.37425,56.2819086,13.719616,-84982.1746633106,697827.776577074,42.318717956543,22,1.62653250229668,-1.78738581325812 +-155.31437,56.2825809,13.719616,-81278.2692222704,697827.779204711,38.3485412597656,22,1.58374884847057,-1.94278825562513 +-155.25449,56.2832232,13.719616,-77574.4960675983,697827.777933327,31.867654800415,22,1.50335010411651,-2.23481944320538 +-155.1946,56.2838356,13.719616,-73870.2306633359,697827.772490312,28.9676132202148,22,1.46191271308458,-2.38533187484228 +-155.13471,56.2844181,13.719616,-70166.0853062041,697827.77482954,25.9036178588867,22,1.4133604245609,-2.56168764496312 +-155.07482,56.2849706,13.719616,-66462.0541717132,697827.773529807,23.9369659423828,22,1.37906910187715,-2.68624351666845 +-155.01493,56.2854932,13.719616,-62758.1310538675,697827.779484046,24.1356582641602,22,1.38265914805191,-2.67320344426052 +-154.95504,56.2859858,13.719616,-59054.3101071929,697827.781298603,26,22,1.41497334797082,-2.55582904676412 +-154.89514,56.2864484,13.719616,-55349.966994068,697827.770409373,26,22,1.41497334797082,-2.55582904676412 +-154.83525,56.2868811,13.719616,-51646.3321398879,697827.774978303,31,22,1.49136169383427,-2.27836477118343 +-154.77535,56.2872839,13.719616,-47942.162935252,697827.778692886,29.4789199829102,22,1.4695115682625,-2.35773066390684 +-154.71545,56.2876567,13.719616,-44238.0717942164,697827.77854911,31.4997749328613,22,1.49830745074942,-2.2531357995512 +-154.65555,56.2879995,13.719616,-40534.0526790008,697827.774373162,44.9468231201172,22,1.65269900084876,-1.6923416218547 +-154.59565,56.2883124,13.719616,-36830.0994515249,697827.777156583,57.8432769775391,22,1.76225288893634,-1.29441063052777 +-154.53575,56.2885953,13.719616,-33126.2061936066,697827.775602363,71.4526596069336,22,1.85401839871297,-0.961092106534896 +-154.47585,56.2888483,13.719616,-29422.3667867817,697827.78073013,85.3184661865234,22,1.9310430393147,-0.681316626848192 +-154.41594,56.2890713,13.719616,-25717.9569910905,697827.777398012,89.4210891723633,22,1.95143995538514,-0.607229205820903 +-154.35604,56.2892643,13.719616,-22014.2073700027,697827.773804914,90.7548522949219,122,1.95786985429849,-0.583873977691753 +-154.29614,56.2894274,13.719616,-18310.4935334548,697827.77658226,92.973030090332,122,1.96835698531053,-0.545781724530823 +-154.23623,56.2895605,13.719616,-14606.1912108145,697827.772303025,93.8814086914062,122,1.97257959756817,-0.530443991557545 +-154.17632,56.2896637,13.719616,-10901.912634306,697827.775371781,113.697570800781,122,2.0557511858919,-0.228341043230962 +-154.11642,56.2897369,13.719616,-7198.2701153961,697827.775672594,124.915863037109,122,2.09661759283397,-0.0799025887835343 +-154.05651,56.2897801,13.719616,-3494.0210121119,697827.770445845,128.738555908203,122,2.10970863323309,-0.032352193498993 +-153.99661,56.2897934,13.719616,209.604112137045,697827.772433203,125.705810546875,134,2.09935535270681,-0.0699582634909006 +-153.9367,56.2897768,13.719616,3913.84786921918,697827.781133936,112.334770202637,134,2.05051420122959,-0.247363266308727 +-153.87679,56.2897301,13.719616,7618.09800872615,697827.774778357,101.111198425293,134,2.00479925791524,-0.413412988770331 +-153.81689,56.2896535,13.719616,11321.7422377138,697827.773986982,91.0995864868164,31,1.95951640565685,-0.577893233185643 +-153.75698,56.289547,13.719616,15026.0231679699,697827.781647343,87.4471588134766,31,1.94174570367548,-0.642441495045285 +-153.69708,56.2894104,13.719616,18729.7103080863,697827.771538257,80.7380523681641,31,1.9070782687805,-0.768363513654925 +-153.63717,56.289244,13.719616,22434.0461472636,697827.782261293,70.5005798339844,31,1.84819268887316,-0.982252747496217 +-153.57727,56.2890475,13.719616,26137.8002749175,697827.774240674,78.3277130126953,31,1.89391544633749,-0.816174641811485 +-153.51737,56.2888211,13.719616,29841.59689946,697827.772691511,74.1340408325195,31,1.87001767290519,-0.902978176021249 +-153.45746,56.2885648,13.719616,33546.0603308652,697827.782770351,77.0741577148438,31,1.88690878734867,-0.841624827158486 +-153.39756,56.2882784,13.719616,37249.9601775974,697827.772749068,74.6201858520508,31,1.87285632637755,-0.892667376377286 +-153.33766,56.2879622,13.719616,40953.9204759179,697827.780708633,78.8245544433594,31,1.89666152457266,-0.806200101852615 +-153.27776,56.2876159,13.719616,44657.9475676041,697827.773342507,136.142990112305,31,2.1339952847952,0.0558638570750754 +-153.21786,56.2872398,13.719616,48362.0471268548,697827.784265454,359.510437011719,134,2.5557115029826,1.58765753132422 +-153.15797,56.2868336,13.719616,52065.6072540283,697827.772359532,368.385406494141,231,2.56630241738637,1.62612675538663 +-153.09807,56.2863975,13.719616,55769.8703162622,697827.775238081,433.922424316406,231,2.63741209425281,1.88441739848804 +-152.97828,56.2854355,13.719616,63178.0562399809,697827.783663816,494.882904052734,134,2.69450245117668,2.09178587004571 +-152.91839,56.2849095,13.719616,66881.9913159623,697827.777393049,201.952911376953,134,2.30525011839153,0.677910293692981 +-152.8585,56.2843536,13.719616,70586.0350914998,697827.778404732,220.29573059082,134,2.34300608045165,0.815050724519817 +-152.79862,56.2837678,13.719616,74289.5752707448,697827.775771056,321.737945556641,231,2.5075022843214,1.41254788886577 +-152.73873,56.283152,13.719616,77993.8546728178,697827.780429738,480.146026611328,330,2.68137333926476,2.04409718816 +-134.01488,54.5552259,13.70907546,1274385.80204914,697827.782597544,233,351,2.36735592102602,0.903496295622358 +-133.96025,54.5453437,13.719616,1278089.87472109,697827.796683736,226,251,2.3541084391474,0.855377660231438 +-133.90565,54.5354353,13.719616,1281793.81796903,697827.78204254,244,251,2.38738982633873,0.976265157963997 +-133.85108,54.5255006,13.719616,1285497.63894479,697827.726738413,250,251,2.39794000867204,1.01458643152041 +-133.79653,54.5155396,13.719616,1289201.9597986,697827.823592162,250,251,2.39794000867204,1.01458643152041 +-133.74202,54.5055524,13.719616,1292905.54443093,697827.694225913,211,251,2.32428245529769,0.74704117370595 +-133.68753,54.495539,13.719616,1296609.63325665,697827.726147899,250,251,2.39794000867204,1.01458643152041 +-133.63307,54.4854994,13.719616,1300313.61178175,697827.723941752,253,251,2.40312052117582,1.03340353159963 +-133.57864,54.4754335,13.719616,1304017.48717488,697827.67572091,243,251,2.38560627359831,0.969786785334167 +-133.52423,54.4653415,13.719616,1307721.87480893,697827.798326573,229,251,2.35983548233989,0.876179915767423 +-133.46986,54.4552234,10.50991045,1311425.54184685,697827.697209791,276,251,2.44090908206522,1.17066237067903 +-158.53829,56.1703507,10.64163471,-281294.14477309,694123.767468307,48.4818458557129,20,1.68557914642411,-1.57291154819715 +-158.24034,56.1813205,7.370983428,-262774.42748716,694123.789435415,21.8998260498047,20,1.34044066525519,-2.82655302413291 +-158.18072,56.1834252,12.07305515,-259069.921088448,694123.758347577,36.6855506896973,20,1.56449504268847,-2.012723573809 +-158.12111,56.1855001,13.719616,-255366.451310532,694123.788754359,81.3294067382812,20,1.91024760432732,-0.756851582330461 +-158.06148,56.1875453,13.719616,-251662.154975229,694123.775471426,120.586540222168,120,2.08129883488984,-0.135544690045439 +-158.00185,56.1895607,13.719616,-247958.264580501,694123.784447441,148.169647216797,120,2.17075924685286,0.189401060747992 +-157.94221,56.1915463,13.719616,-244254.155344391,694123.77797356,117.213531494141,120,2.06897775088015,-0.180298383956146 +-157.88257,56.1935021,13.719616,-240550.44020129,694123.793028329,155.990142822266,120,2.19309715570605,0.27053872157674 +-157.82292,56.1954281,13.719616,-236846.494366152,694123.793045571,223.969757080078,120,2.35018937895929,0.841142515017074 +-157.76326,56.1973243,13.719616,-233142.311911359,694123.77880962,144.483993530273,120,2.15981973701284,0.14966563856207 +-157.7036,56.1991908,13.719616,-229438.505145251,694123.796799894,102.572807312012,120,2.01103224187125,-0.390773011971369 +-157.64393,56.2010274,13.719616,-225734.450531353,694123.789898354,125.062232971191,120,2.09712617868984,-0.078055259790175 +-157.58425,56.2028342,13.719616,-222030.141506134,694123.770062878,166.096420288086,120,2.22036027263271,0.36956614392266 +-157.52457,56.2046112,13.719616,-218326.190995119,694123.771007305,179.664489746094,120,2.25446224833171,0.493434253334384 +-157.46488,56.2063584,13.719616,-214621.974204527,694123.759593668,151.633102416992,120,2.18079402074009,0.22585022371602 +-157.40519,56.2080758,13.719616,-210918.10405712,694123.768447584,147.211776733398,120,2.16794255433399,0.179170029555363 +-157.34549,56.2097634,13.719616,-207213.955756384,694123.765573904,149.965759277344,120,2.17599211069284,0.208408315822838 +-157.28579,56.2114211,13.719616,-203510.142773874,694123.771373006,136.202270507812,120,2.13418434737702,0.0565505863361063 +-157.22608,56.213049,13.719616,-199806.039738951,694123.766128592,115.511093139648,120,2.06262369382119,-0.203378132822723 +-157.16637,56.2146471,13.719616,-196102.259569101,694123.78029006,97.6860198974609,120,1.98983241514333,-0.467776833680162 +-157.10665,56.2162153,13.719616,-192398.177984077,694123.773009285,92.3728637695312,21,1.96554440795138,-0.555997808288736 +-157.04693,56.2177537,13.719616,-188694.407357398,694123.784785205,91.2375793457031,21,1.96017375434738,-0.575505555115619 +-156.9872,56.2192622,13.719616,-184990.323386334,694123.775911619,96.6806869506836,21,1.98533972756341,-0.484095557311122 +-156.92746,56.2207409,13.719616,-181285.919603076,694123.758502813,83.9951553344727,21,1.92425423758353,-0.705975492452734 +-156.86773,56.2221898,13.719616,-177582.427777992,694123.787027848,85.4612045288086,21,1.93176900966686,-0.678679695316586 +-156.80798,56.2236088,12.24932482,-173877.985856881,694123.7694561,65.3239669799805,21,1.81507255060845,-1.10255454310228 +-156.74824,56.2249979,13.51141741,-170174.444436732,694123.785349397,71.3515243530273,21,1.85340325581137,-0.963326481132759 +-156.68848,56.2263572,13.719616,-166469.940508417,694123.768332454,89.8112030029297,21,1.95333051371504,-0.60036215834763 +-156.62873,56.2276866,13.719616,-162766.325138088,694123.783507265,153.842575073242,121,2.18707654067101,0.248670129314857 +-156.56897,56.2289861,13.719616,-159062.354624732,694123.780681893,187.226028442383,121,2.27236622486743,0.55846660641579 +-156.5092,56.2302558,13.719616,-155358.022562989,694123.772069964,214.143020629883,121,2.33070392439533,0.770365782338332 +-156.44943,56.2314956,13.719616,-151653.942267937,694123.770449316,231.519714355469,220,2.36458797795119,0.893442336324962 +-156.38966,56.2327055,13.719616,-147950.10775344,694123.775244902,256.536865234375,220,2.4091497835509,1.05530353346873 +-156.32989,56.2338855,13.719616,-144246.513032404,694123.785895504,268.689422607422,220,2.42925057006678,1.1283153274301 +-156.2701,56.2350357,13.719616,-140541.914017782,694123.770673287,263.535034179688,220,2.42083835821849,1.09775977291279 +-156.21032,56.2361559,13.719616,-136838.16206971,694123.771916544,256.145843505859,220,2.40848731294664,1.05289725114611 +-156.15053,56.2372463,13.719616,-133134.012728274,694123.76962774,248.333419799805,220,2.39503516924435,1.00403522559535 +-156.09074,56.2383068,13.719616,-129430.079242809,694123.773318802,236.626724243164,220,2.3740637915849,0.927861196109105 +-156.03095,56.2393374,13.719616,-125726.355621756,694123.782497588,221.853591918945,220,2.3460664645511,0.826166913089614 +-155.97115,56.2403381,13.719616,-122022.217013777,694123.778311982,211.557586669922,220,2.32542860418778,0.7512043136182 +-155.91135,56.2413089,13.719616,-118318.276284647,694123.779786791,122.226364135742,121,2.08716489300742,-0.114237492622726 +-155.85154,56.2422498,13.719616,-114613.908581452,694123.769213057,71.9281845092773,121,1.85689909870544,-0.950628581928604 +-155.79174,56.2431608,13.719616,-110910.345627388,694123.781228323,71.0762023925781,22,1.85172421536276,-0.969425235287989 +-155.73193,56.2440419,13.719616,-107206.343709109,694123.781450793,68.4212646484375,22,1.83519109710368,-1.02947823982673 +-155.67212,56.2448931,13.719616,-103502.515689423,694123.786729703,65.5368728637695,22,1.81648571488569,-1.09742152709008 +-155.6123,56.2457144,13.719616,-99798.2367125528,694123.781642411,62.3320999145508,22,1.79471175814404,-1.17651075288177 +-155.55248,56.2465057,13.719616,-96094.1199006206,694123.770802256,56.061653137207,22,1.74866590002044,-1.34376245238308 +-155.49266,56.2472672,13.719616,-92390.1587241526,694123.776137797,52.9850463867188,22,1.72415331888261,-1.43279914366291 +-155.43284,56.2479987,13.719616,-88686.3476956872,694123.774998832,47.822452545166,22,1.6796318448772,-1.5945138449444 +-155.37301,56.2487004,13.719616,-84982.0614657631,694123.776546256,42.3187255859375,22,1.62653258059309,-1.78738552886322 +-155.31318,56.2493721,13.719616,-81277.9133645516,694123.772068533,35.2961692810059,22,1.54772757364854,-2.07362780727418 +-155.25336,56.2500139,13.719616,-77574.5160100079,694123.784083221,28.0406055450439,22,1.44778738811172,-2.43663908691283 +-155.19352,56.2506258,13.719616,-73870.0068243308,694123.777249423,24.8317070007324,22,1.3950065751936,-2.62835406457532 +-155.13369,56.2512077,13.719616,-70166.2365732892,694123.775176,27.1581134796143,22,1.43389959867735,-2.48708350210823 +-155.07385,56.2517597,13.719616,-66461.9613266295,694123.767053279,28.2493324279785,22,1.45100818927861,-2.4249402177665 +-155.01402,56.2522819,13.719616,-62758.4126296419,694123.784347913,26.8111686706543,22,1.42831574483534,-2.50736565305296 +-154.95418,56.252774,13.719616,-59054.347272425,694123.773909684,33.304573059082,22,1.52250387068247,-2.16524749600856 +-154.89434,56.2532363,13.719616,-55350.3775999666,694123.77896761,30.5253143310547,22,1.48466014473943,-2.30270671030844 +-154.8345,56.2536686,13.719616,-51646.4979190985,694123.777006443,35.4547843933105,22,1.54967484869856,-2.06655474848486 +-154.77465,56.254071,13.719616,-47942.0832067445,694123.771756438,39.3872909545898,22,1.59535611119928,-1.90062736435182 +-154.71481,56.2544435,13.719616,-44238.3651765738,694123.778026382,50.4791946411133,22,1.70311241743833,-1.50922570337972 +-154.65496,56.254786,13.719616,-40534.1002161132,694123.770612107,61.8145370483398,22,1.79109062100235,-1.18966375655584 +-154.59511,56.2550986,13.719616,-36829.9010494223,694123.76772403,78.4582443237305,22,1.89463858560531,-0.813547993586293 +-154.53527,56.2553813,13.719616,-33126.3805303711,694123.774204901,85.5052108764648,22,1.93199258239993,-0.677867615336054 +-154.47542,56.2556341,13.719616,-29422.2949357359,694123.779389518,91.7608642578125,22,1.96265749535345,-0.566483898851328 +-154.41557,56.2558569,13.719616,-25718.2571887204,694123.777555064,85.5392990112305,122,1.93216568692147,-0.677238850304871 +-154.35572,56.2560498,13.719616,-22014.2611937322,694123.779748977,85.2344360351562,122,1.93061509193263,-0.682871053888218 +-154.29587,56.2562127,13.719616,-18310.3009945739,694123.774730351,103.458114624023,122,2.0147645597502,-0.377216168125438 +-154.23602,56.2563457,13.719616,-14606.3705154441,694123.773574608,126.773162841797,122,2.10302732560168,-0.0566206098513384 +-154.17617,56.2564488,13.719616,-10902.4637502058,694123.776219935,130.164154052734,122,2.11449140020379,-0.0149798187238213 +-154.11631,56.2565219,13.719616,-7197.95585320444,694123.770383175,138.315246582031,122,2.14087005531888,0.0808349858719773 +-154.05646,56.2565652,13.719616,-3494.07848693984,694123.781058499,143.369033813477,122,2.15645535847133,0.137445255410066 +-153.99661,56.2565784,13.719616,209.79318544328,694123.773130155,130.252548217773,134,2.11478622844828,-0.0139089183874725 +-153.93676,56.2565618,13.719616,3913.6651987604,694123.780046018,123.127571105957,134,2.09035531238259,-0.102648978815744 +-153.87691,56.2565152,13.719616,7617.54357056148,694123.779511125,110.358993530273,134,2.04280773107643,-0.275355365550559 +-153.81705,56.2564386,13.719616,11322.0531962947,694123.77325199,102.78337097168,134,2.01192285707742,-0.387538043335646 +-153.7572,56.2563322,13.719616,15025.9623129516,694123.780754942,93.9347457885742,134,1.97282626439688,-0.52954802722993 +-153.69735,56.2561958,13.719616,18729.8958572017,694123.780913959,90.2490844726562,134,1.95544280492129,-0.592689713778576 +-153.6375,56.2560294,13.719616,22433.8598653157,694123.773792554,87.3844146728516,31,1.94143398154576,-0.643573758794797 +-153.57765,56.2558332,13.719616,26137.8602316096,694123.781770459,86.3230590820312,31,1.93612682230165,-0.662850875983447 +-153.5178,56.2556069,13.719616,29841.9031747029,694123.771485538,87.8188934326172,31,1.94358796044844,-0.635749892613465 +-153.45795,56.2553508,13.719616,33545.9944875339,694123.776496283,85.6958694458008,31,1.93295988936628,-0.674354080337377 +-153.39811,56.2550647,13.719616,37249.5214886402,694123.769010743,94.6362075805664,31,1.97605732819813,-0.517811881266368 +-153.33826,56.2547487,13.719616,40953.7278202536,694123.770973119,125.728729248047,134,2.09943452612099,-0.0696706830522652 +-153.27841,56.2544028,13.719616,44658.0006284716,694123.777479056,396.535247802734,134,2.59828179757002,1.74228499203749 +-153.21857,56.2540269,13.719616,48361.7271903468,694123.770256527,684.072021484375,231,2.83510182816256,2.60248293831598 +-152.85953,56.2511433,13.719616,70585.9458970636,694123.77959647,666.883728027344,330,2.82405012075626,2.56233998254498 +-133.97724,54.5135505,13.719616,1278089.58538611,694123.716372109,227,251,2.35602585719312,0.862342269859097 +-133.92268,54.5036497,13.719616,1281793.56108366,694123.706789842,212,251,2.32633586092875,0.754499729058273 +-133.86814,54.4937226,13.719616,1285498.02965178,694123.84722351,233,251,2.36735592102602,0.903496295622358 +-133.81364,54.4837693,13.719616,1289201.75389237,694123.760400685,243,251,2.38560627359831,0.969786785334167 +-133.75916,54.4737898,13.719616,1292905.97534116,694123.832700983,212,251,2.32633586092875,0.754499729058273 +-133.70471,54.4637841,13.719616,1296610.07895177,694123.869252588,218,251,2.3384564936046,0.798525326509967 +-133.65029,54.4537522,13.719616,1300314.06853149,694123.868757387,211,251,2.32428245529769,0.74704117370595 +-133.5959,54.4436941,13.719616,1304017.94788233,694123.8299241,211,251,2.32428245529769,0.74704117370595 +-133.54154,54.4336098,10.33351137,1307721.720801,694123.751468251,221,251,2.34439227368511,0.820085774002676 +-158.65324,56.1326161,5.675878796,-288702.061593434,690419.760377494,79.8220748901367,20,1.90212301261895,-0.786362418404581 +-158.29608,56.1460361,13.47405596,-266478.179801412,690419.777441388,58.8141212463379,20,1.76948161252281,-1.2681538431786 +-158.23653,56.1481687,13.719616,-262774.288350462,690419.781546589,81.526725769043,20,1.91130000078115,-0.753028978026282 +-158.17697,56.1502716,13.14513715,-259070.199867826,690419.777032594,54.2798614501953,20,1.73463873044878,-1.39471313602014 +-158.1174,56.1523447,10.53326393,-255365.909158985,690419.753477655,32.440013885498,20,1.51108103143289,-2.20673850856595 +-158.05783,56.1543881,13.719616,-251662.029042866,690419.760623787,63.8684730529785,20,1.80528653330856,-1.1381001511429 +-157.99825,56.1564018,13.719616,-247957.934214208,690419.760194676,113.03929901123,120,2.05322945566553,-0.237500687186597 +-157.93867,56.1583857,13.719616,-244254.238860459,690419.778586296,114.096229553223,120,2.0572712928732,-0.222819580793144 +-157.87908,56.1603398,13.719616,-240550.31764329,690419.778663001,114.325187683105,120,2.05814192301725,-0.219657203607379 +-157.81948,56.1622642,13.719616,-236846.163998613,690419.772328898,217.726821899414,120,2.33791193333775,0.796547328187761 +-157.75988,56.1641588,13.719616,-233142.392079332,690419.784345635,128.994445800781,120,2.11057101099691,-0.0292197913137002 +-157.70027,56.1660237,13.719616,-229438.375921652,690419.790424265,124.584495544434,120,2.09546399803367,-0.0840927743669778 +-157.64065,56.1678587,13.719616,-225734.110849817,690419.769113042,104.019233703613,120,2.01711365005871,-0.368683601627787 +-157.58103,56.169664,13.719616,-222030.209119568,690419.776937759,137.896423339844,120,2.13955300189801,0.0760510719228944 +-157.5214,56.1714395,13.719616,-218326.046004667,690419.769057903,173.594329833984,120,2.23953553557533,0.439216172095209 +-157.46177,56.1731852,13.719616,-214622.234989926,690419.778644821,148.578796386719,120,2.17195683587616,0.19375104590656 +-157.40213,56.1749011,13.719616,-210918.150725405,690419.77313354,152.888595581055,120,2.18437509129239,0.238857694101281 +-157.34249,56.1765872,13.719616,-207214.406693196,690419.784607212,151.738739013672,120,2.18109647064884,0.226948808112404 +-157.28284,56.1782435,13.719616,-203510.37754068,690419.781643606,145.972702026367,120,2.1642716471011,0.165836246704289 +-157.22318,56.17987,13.719616,-199806.057330632,690419.765151417,122.00422668457,120,2.08637487652712,-0.117107057972334 +-157.16352,56.1814667,13.719616,-196102.059541231,690419.765581515,104.054916381836,120,2.01726260455784,-0.368142556371114 +-157.10386,56.1830336,13.719616,-192398.378232712,690419.782196695,93.7374267578125,21,1.97191302727016,-0.532865165138023 +-157.04419,56.1845707,13.719616,-188694.388047386,690419.785860328,96.3713760375977,21,1.98394806009698,-0.489150490770617 +-156.98451,56.1860779,13.719616,-184990.083543976,690419.766396616,99.8232498168945,21,1.999231704526,-0.433635931818012 +-156.92483,56.1875554,13.719616,-181286.077183901,690419.774357998,79.1112518310547,21,1.89823825670394,-0.800472960707624 +-156.86515,56.189003,13.719616,-177582.36401445,690419.786783229,82.8991394042969,21,1.91855002205926,-0.726694831382088 +-156.68607,56.1931668,13.719616,-166470.444416603,690419.788508213,83.8229217529297,21,1.9233627946398,-0.709213467667522 +-156.62636,56.194495,13.719616,-162765.985149401,690419.763214371,152.539855957031,121,2.1833833319498,0.235255341092693 +-156.56666,56.1957935,13.719616,-159062.407778193,690419.788754793,190.554580688477,121,2.28001939311772,0.586265097932546 +-156.50695,56.197062,13.719616,-155358.46881104,690419.782642618,218.092071533203,121,2.33863987762837,0.79919142962729 +-156.44723,56.1983008,13.719616,-151654.161003355,690419.77939117,234.998016357422,220,2.37106419636254,0.916965810091753 +-156.38751,56.1995096,13.719616,-147950.099051174,690419.768949959,256.841003417969,220,2.40966435793514,1.05717261450646 +-156.32779,56.2006886,13.719616,-144246.276158843,690419.773045214,253.301452636719,220,2.40363768039577,1.03528200149842 +-156.26806,56.2018378,13.719616,-140542.066954723,690419.769969237,245.368789672852,220,2.38981932067758,0.985089774849411 +-156.20833,56.2029571,13.719616,-136838.085270364,690419.770324061,250.968734741211,220,2.39961962118178,1.02068726356492 +-156.1486,56.2040466,13.719616,-133134.324758259,690419.784735705,245.977020263672,220,2.39089453621377,0.988995264573929 +-156.08886,56.2051061,13.719616,-129430.160745446,690419.770920695,237.693557739258,220,2.37601741110889,0.934957299838733 +-156.02912,56.2061358,13.719616,-125726.205948726,690419.77128254,224.918518066406,220,2.35202521338573,0.847810789653207 +-155.96938,56.2071357,13.719616,-122022.454408829,690419.785344865,212.551010131836,220,2.32746317325816,0.758594449205672 +-155.90963,56.2081056,13.719616,-118318.281390181,690419.772536802,75.0934371948242,220,1.87560198341407,-0.882694366332097 +-155.84988,56.2090457,13.719616,-114614.299667352,690419.773632016,71.0154037475586,121,1.85135256050759,-0.97077519180283 +-155.79013,56.209956,13.719616,-110910.503278751,690419.788195488,67.6232757568359,22,1.83009620471221,-1.04798434321961 +-155.73037,56.2108363,13.719616,-107206.267426392,690419.777369193,68.5743637084961,22,1.8361617865402,-1.02595241873092 +-155.67061,56.2116868,13.719616,-103502.204942829,690419.7802968,62.0745582580566,22,1.79291363766243,-1.18304203970567 +-155.61085,56.2125073,13.719616,-99798.3104052581,690419.774289708,59.6445426940918,22,1.77557071311506,-1.24603649182522 +-155.55108,56.213298,13.719616,-96093.9578516359,690419.766792389,49.29736328125,22,1.69282369122395,-1.54659729368516 +-155.49132,56.2140588,13.719616,-92390.3804007464,690419.775787797,50.1205558776855,22,1.70001587902747,-1.52047321472799 +-155.43155,56.2147898,13.719616,-88686.3329831804,690419.783689726,47.1763305664062,22,1.67372415789895,-1.61597225027112 +-155.37178,56.2154908,13.719616,-84982.4295100881,690419.782332535,39.5448112487793,22,1.59708950695238,-1.89433117621617 +-155.312,56.2161619,13.719616,-81278.0443175676,690419.770300289,35.436336517334,22,1.54944881726282,-2.06737575917526 +-155.25223,56.2168032,13.719616,-77574.4100313849,690419.783465512,26.4913997650146,22,1.42310490635918,-2.52629290571975 +-155.19245,56.2174145,13.719616,-73870.2822507942,690419.775313614,24.1925277709961,22,1.3836812482561,-2.66949088458246 +-155.13267,56.217996,13.719616,-70166.2739836515,690419.78009744,27.6232490539551,22,1.4412747590803,-2.46029481444433 +-155.07289,56.2185475,13.719616,-66462.3796214923,690419.775248936,26.552152633667,22,1.42409973592694,-2.52267940077701 +-155.0131,56.2190692,13.719616,-62757.9733780183,690419.773360784,31.7178955078125,22,1.50130436402814,-2.24225015511868 +-154.95332,56.219561,13.719616,-59054.2882770659,690419.782499312,35.6008987426758,22,1.55146096185091,-2.0600670757081 +-154.89353,56.2200228,13.719616,-55350.0796351641,690419.772944256,37.4449081420898,22,1.57339276953509,-1.98040449023801 +-154.83374,56.2204548,13.719616,-51645.9605584248,690419.776230772,45.1951599121094,22,1.65509192737742,-1.68364982969336 +-154.77395,56.2208568,13.719616,-47941.9253360124,690419.769858543,46.9873428344727,22,1.6719808860752,-1.62230431111431 +-154.71416,56.221229,13.719616,-44237.9676968209,690419.775941044,70.9367904663086,22,1.85087153493513,-0.972522413980356 +-154.65437,56.2215712,13.719616,-40534.0818892311,690419.772005207,80.8549957275391,22,1.90770685850186,-0.766080296369575 +-154.59458,56.2218836,13.719616,-36830.2616817045,690419.78019272,88.8223342895508,22,1.94852218243538,-0.617827389989735 +-154.53479,56.222166,13.719616,-33126.501281924,690419.778057843,88.4517211914062,22,1.94670628831027,-0.624423235759939 +-154.47499,56.2224185,13.719616,-29422.1751610807,690419.772189452,88.4317626953125,122,1.94660828181959,-0.624779223307922 +-154.4152,56.2226412,13.719616,-25718.516080379,690419.783039441,85.7976913452148,122,1.93347560195683,-0.672480865009488 +-154.3554,56.2228339,13.719616,-22014.2793532573,690419.77990022,104.293846130371,122,2.01825868358982,-0.364524513017695 +-154.2956,56.2229967,13.719616,-18310.0783138395,690419.778263296,129.519515991211,122,2.11233521280879,-0.0228117067796068 +-154.2358,56.2231296,13.719616,-14605.9069591737,690419.778053081,125.78148651123,122,2.09961672300351,-0.0690088919707745 +-154.17601,56.2232326,13.719616,-10902.3787028818,690419.780849496,130.998641967773,122,2.11726679344997,-0.00489879827759439 +-154.11621,56.2233056,13.719616,-7198.24872793391,690419.771612837,140.313278198242,122,2.14709877135168,0.103459460355635 +-154.05641,56.2233488,13.719616,-3494.13039872384,690419.774810323,161.325424194336,122,2.20770281572875,0.323590647649599 +-153.99661,56.2233621,13.719616,209.982258471626,690419.77927103,169.898864746094,134,2.23019047694936,0.405272251820403 +-153.93681,56.2233454,13.719616,3914.09525756292,690419.773837887,146.313659667969,134,2.16528487323056,0.16951657321 +-153.87702,56.2232989,13.719616,7617.59517397485,690419.779673344,127.198867797852,134,2.10448324565726,-0.0513322926485342 +-153.81722,56.2232224,13.719616,11321.7268756226,690419.776233641,117.779602050781,134,2.07107008260853,-0.172698437907737 +-153.75742,56.223116,13.719616,15025.8769384305,690419.774115866,111.07886505127,134,2.04563143369535,-0.265098871673679 +-153.69762,56.2229797,13.719616,18730.0513655507,690419.77336941,101.045776367188,134,2.00451816506795,-0.41443399822357 +-153.63783,56.2228135,13.719616,22433.6367433482,690419.770679511,99.6923751831055,134,1.99866194324111,-0.435705467430798 +-153.57803,56.2226174,13.719616,26137.8779081432,690419.77232164,94.8084716796875,134,1.9768471457701,-0.514943038408592 +-153.51824,56.2223914,13.719616,29841.5420293478,690419.771073048,98.0433502197266,134,1.99141814302354,-0.462017017407407 +-153.45844,56.2221355,13.719616,33545.8739429732,690419.775467903,234.809921264648,134,2.370716442914,0.915702670307946 +-153.39865,56.2218497,13.719616,37249.6408180757,690419.776080284,126.223388671875,134,2.10113983533599,-0.063476513239669 +-153.33885,56.221534,13.719616,40954.0874902626,690419.783703059,240.375625610352,134,2.38089042755863,0.952657486481579 +-133.93967,54.4718599,13.719616,1281794.05226012,690419.858325606,365,450,2.56229286445647,1.61156291470491 +-133.88518,54.4619405,13.719616,1285497.92374926,690419.819131187,357,351,2.55266821611219,1.57660344477034 +-133.83072,54.4519948,13.719616,1289201.66936692,690419.732174913,234,251,2.36921585741014,0.910252115448194 +-133.77628,54.442023,13.719616,1292905.9057036,690419.812051659,215,251,2.33243845991561,0.776666110433694 +-133.72187,54.432025,13.719616,1296610.02047301,690419.853266569,212,251,2.32633586092875,0.754499729058273 +-133.66749,54.4220007,13.719616,1300314.02083485,690419.843910021,206,251,2.31386722036915,0.709210067641479 +-133.61314,54.4119504,10.15239394,1304017.90053434,690419.814499984,207,251,2.31597034545692,0.716849218251904 +-158.64907,56.0994761,10.24573376,-288702.213772161,686715.772886887,91.1462860107422,20,1.95973897690869,-0.577084790870794 +-158.58961,56.1017851,6.295260848,-284997.953627279,686715.759212526,26.0066680908203,20,1.41508471503855,-2.55542452978678 +-158.35172,56.1107241,13.51900846,-270182.325160587,686715.785482473,86.934440612793,20,1.93919186396173,-0.651717769824058 +-158.29223,56.1128846,13.719616,-266478.431710273,686715.79128643,66.8821334838867,20,1.82531011828115,-1.06536877522229 +-158.23273,56.1150154,13.719616,-262774.34597835,686715.785253905,102.29125213623,20,2.00983849479321,-0.395109042088153 +-158.17322,56.1171165,13.719616,-259070.062083973,686715.768080088,62.8963050842285,20,1.79862513306587,-1.16229625817728 +-158.11371,56.1191879,13.61323285,-255366.194119107,686715.778925956,56.8537063598633,20,1.75475878211378,-1.32163136553838 +-158.05419,56.1212295,13.719616,-251662.116905453,686715.767817075,80.7118606567383,20,1.90693735924849,-0.768875337294766 +-157.99467,56.1232415,13.719616,-247958.443161354,686715.79508274,97.5892639160156,120,1.98940204227226,-0.469340070788524 +-157.93513,56.1252237,13.719616,-244253.928401175,686715.763982456,153.65071105957,120,2.18653457441038,0.246701553163677 +-157.8756,56.1271761,13.719616,-240550.426629493,686715.785614433,150.775634765625,120,2.17833116552719,0.216904430613925 +-157.81605,56.1290989,13.719616,-236846.070722141,686715.772677918,196.969345092773,120,2.294398640918,0.638494630189072 +-157.7565,56.1309918,13.719616,-233142.096657114,686715.764454075,156.300888061523,120,2.19396144557596,0.273678069077138 +-157.69695,56.1328551,13.719616,-229438.496620176,686715.793466486,107.958518981934,120,2.03325691810025,-0.310046644353492 +-157.63738,56.1346886,13.719616,-225734.026018417,686715.768613565,106.381767272949,120,2.02686720078541,-0.333255921447867 +-157.57781,56.1364923,13.719616,-222029.918874566,686715.759262545,108.537986755371,120,2.03558176169581,-0.301602148837994 +-157.51824,56.1382663,13.719616,-218326.168670686,686715.77571641,154.257293701172,120,2.18824570780598,0.252916878062606 +-157.45866,56.1400105,13.719616,-214622.150113793,686715.773707511,156.288543701172,120,2.19392714443177,0.273553477530907 +-157.39908,56.1417249,13.719616,-210918.477248009,686715.785864685,160.830200195312,120,2.20636760253855,0.318740772235002 +-157.33948,56.1434096,13.719616,-207213.903632401,686715.760129846,153.654663085938,120,2.18654574468847,0.24674212680201 +-157.27989,56.1450645,13.719616,-203510.283837703,686715.779870189,140.305923461914,120,2.14707600654168,0.103376772067995 +-157.22029,56.1466896,13.719616,-199806.37198079,686715.782476936,107.35139465332,120,2.03080769093628,-0.318942936492054 +-157.16068,56.1482849,13.719616,-196102.162126111,686715.768873884,97.7506866455078,21,1.99011981676159,-0.466732908970039 +-157.10107,56.1498505,13.719616,-192398.267790844,686715.780107058,98.9957046508789,21,1.99561635129562,-0.446767926675276 +-157.04145,56.1513862,13.719616,-188694.064113434,686715.764766302,91.2842864990234,21,1.96039602535367,-0.574698203378329 +-156.98183,56.1528922,13.719616,-184990.164098159,686715.77394765,93.5947189331055,21,1.97125134443345,-0.535268586064031 +-156.9222,56.1543684,13.719616,-181285.942350619,686715.768520984,84.0636901855469,21,1.92460845052838,-0.704688889934612 +-156.86257,56.1558147,13.719616,-177582.013384117,686715.765078589,80.6908645629883,21,1.90682436874358,-0.769285751059317 +-156.7433,56.158618,12.47002026,-170174.388085936,686715.780422771,64.7281341552734,21,1.81109308828245,-1.11700908612196 +-156.68365,56.159975,13.719616,-166470.059911049,686715.773965182,80.3721237182617,21,1.90510544408918,-0.775529376034014 +-156.624,56.1613021,13.719616,-162766.00069967,686715.769133329,151.329116821289,121,2.17992249747604,0.222684602463509 +-156.56435,56.1625994,13.719616,-159062.204044293,686715.77645499,200.821334838867,121,2.302809849462,0.669046540418842 +-156.50469,56.1638669,13.719616,-155358.044022407,686715.771937759,221.696228027344,121,2.34575830402632,0.825047586105836 +-156.44503,56.1651045,13.719616,-151654.135069776,686715.768362667,240.705123901367,121,2.38148533522062,0.954818360913488 +-156.38537,56.1663124,13.719616,-147950.470405498,686715.787442857,247.191986083984,220,2.39303438690254,0.996767813049733 +-156.3257,56.1674904,13.719616,-144246.424914953,686715.78461476,230.559158325195,220,2.36278237804577,0.886883882098966 +-156.26602,56.1686386,13.719616,-140541.992235774,686715.772150002,231.460494995117,220,2.36447687755837,0.893038787987041 +-156.20635,56.1697569,13.719616,-136838.406734335,686715.781256855,241.353485107422,220,2.3826535743459,0.959061738865145 +-156.14667,56.1708454,13.719616,-133134.422117641,686715.780794729,243.98991394043,220,2.38737187383647,0.97619994935164 +-156.08698,56.1719041,13.719616,-129430.032431086,686715.771933921,239.592102050781,220,2.37947249780618,0.947507160903239 +-156.0273,56.1729329,13.719616,-125726.472008411,686715.782576453,227.240798950195,220,2.35648630753292,0.864014756918867 +-155.96761,56.1739319,13.719616,-122022.49458414,686715.784970492,188.199859619141,220,2.27461929514514,0.56665040075471 +-155.90791,56.174901,13.719616,-118318.094521511,686715.769181895,68.3013076782227,121,1.83442901864492,-1.03224632630778 +-155.84822,56.1758403,13.719616,-114614.505471237,686715.78209762,67.5556182861328,121,1.82966147310936,-1.04956341248592 +-155.78852,56.1767498,13.719616,-110910.481525887,686715.788209116,65.6950531005859,22,1.8175326680072,-1.09361869452261 +-155.72881,56.1776293,13.719616,-107206.017306636,686715.766476199,65.0419158935547,22,1.81319332547875,-1.10938042515759 +-155.66911,56.1784791,13.719616,-103502.345901595,686715.782774278,61.5498428344727,22,1.78922694831188,-1.19643314771277 +-155.6094,56.1792989,13.719616,-99798.2222418684,686715.771542313,55.4918823242188,22,1.74422945664254,-1.35987688101862 +-155.54969,56.180089,13.719616,-96094.2594999296,686715.781984327,47.9632949829102,22,1.68090901061825,-1.58987481443348 +-155.48998,56.1808491,13.719616,-92390.4524943294,686715.780293223,48.5074806213379,22,1.68580871885067,-1.57207767561738 +-155.43026,56.1815794,13.719616,-88686.1747476989,686715.775057392,42.7692031860352,22,1.63113115918523,-1.77068217885155 +-155.37054,56.1822798,13.719616,-84982.0405014186,686715.769260784,37.7583160400391,22,1.5770126172249,-1.96725617022121 +-155.31082,56.1829504,13.719616,-81278.0435416451,686715.773726971,31.5346698760986,22,1.49878828889715,-2.2513892581538 +-155.2511,56.1835911,13.719616,-77574.1781141813,686715.776997444,24.9015808105469,22,1.39622691799957,-2.62392143118351 +-155.19138,56.1842019,13.719616,-73870.4382241999,686715.778775251,29.4789562225342,22,1.46951210215788,-2.35772872464645 +-155.13165,56.1847829,13.719616,-70166.197711956,686715.779360574,30.2013149261475,22,1.48002585198821,-2.31953978433971 +-155.07192,56.185334,13.719616,-66462.0707661358,686715.779016706,32.4720230102539,22,1.51150934605814,-2.20518274759385 +-155.01219,56.1858552,13.719616,-62758.0513905055,686715.777488153,36.2111511230469,22,1.55884233090486,-2.03325583645165 +-154.95246,56.1863465,13.719616,-59054.1335884088,686715.774533324,41.0146713256836,22,1.61293923564771,-1.83676043763174 +-154.89273,56.186808,13.719616,-55350.3112129069,686715.781073857,44.7525978088379,22,1.65081825040718,-1.69917304427815 +-154.83299,56.1872396,13.719616,-51645.9584620816,686715.777969956,52.0764617919922,22,1.71664146948461,-1.46008432477172 +-154.77326,56.1876413,13.719616,-47942.3092870143,686715.781132754,64.5880661010742,22,1.81015228107193,-1.12042636644365 +-154.71352,56.1880131,13.719616,-44238.1177407366,686715.775380268,88.1338577270508,22,1.94514278014031,-0.630102343702869 +-154.65378,56.188355,13.719616,-40533.9977992687,686715.768316864,95.3899002075195,22,1.97950239444894,-0.505298417323639 +-154.59404,56.1886671,13.719616,-36829.9433641769,686715.770933975,93.5682754516602,22,1.97112862510864,-0.535714337679333 +-154.5343,56.1889493,13.719616,-33125.9485563129,686715.771937123,90.2051010131836,122,1.95523109717874,-0.593458696726956 +-154.47456,56.1892016,13.719616,-29422.0073764906,686715.771195464,89.2228622436523,122,1.95047615117062,-0.610730017825138 +-154.41482,56.1894241,13.719616,-25718.1137556706,686715.779742213,103.595603942871,122,2.01534132660747,-0.37512118627417 +-154.35508,56.1896166,13.719616,-22014.2618435992,686715.775173881,125.211265563965,122,2.09764340516962,-0.0761765455844573 +-154.29534,56.1897793,13.719616,-18310.4455112711,686715.779701675,113.715866088867,122,2.05582106340474,-0.228087228159312 +-154.23559,56.1899121,13.719616,-14606.0388540167,686715.779900551,111.525718688965,122,2.04737503058342,-0.258765630104105 +-154.17585,56.190015,13.719616,-10902.2758206979,686715.780665411,122.255981445312,122,2.0872701164267,-0.113855291130137 +-154.1161,56.190088,13.719616,-7197.91046236378,686715.778107562,145.048843383789,122,2.16151427009807,0.15582066639552 +-154.05636,56.1901311,13.719616,-3494.17672771762,686715.774918631,171.044357299805,122,2.2331087515174,0.415872258010009 +-153.99662,56.1901444,13.719616,209.551357315939,686715.780587471,189.477600097656,134,2.27755787536484,0.577324162866956 +-153.93687,56.1901277,13.719616,3913.89975849654,686715.773396363,190.745254516602,134,2.28045374210325,0.587842777423505 +-153.87713,56.1900812,13.719616,7617.63451602596,686715.775033009,184.957626342773,134,2.26707224324968,0.539237354127317 +-153.81738,56.1900048,13.719616,11322.0015795321,686715.776104921,184.086120605469,134,2.2650210455834,0.531786818733274 +-153.75764,56.1898985,13.719616,15025.7670003135,686715.773795635,170.139282226562,134,2.23080459629714,0.407502908578637 +-153.6979,56.1897623,13.719616,18729.5567528799,686715.769301543,135.717468261719,134,2.13263574951257,0.0509256368785693 +-153.63815,56.1895963,13.719616,22433.9967508946,686715.777214067,127.750198364258,134,2.1063615831585,-0.0445096347131221 +-153.57841,56.1894004,13.719616,26137.8530860586,686715.780261518,114.39249420166,134,2.05839752940682,-0.218728768243149 +-153.51867,56.1891745,13.719616,29841.7518133408,686715.770204892,112.444564819336,134,2.05093846798848,-0.245822208342658 +-153.45893,56.1889189,13.719616,33545.6986898582,686715.78059933,128.695770263672,134,2.10956427354515,-0.0328765490899516 +-153.39919,56.1886333,13.719616,37249.6999574273,686715.778112947,183.949584960938,134,2.26469881228469,0.53061637541783 +-153.33945,56.1883178,13.719616,40953.7615343891,686715.774028325,602.049133300781,231,2.77963193552804,2.4010004555838 +-133.84777,54.4202162,13.719616,1289201.70733765,686715.750883638,233,450,2.36735592102602,0.903496295622358 +-133.79337,54.410252,13.719616,1292905.95825668,686715.828316577,251,251,2.39967372148104,1.0208837712936 +-133.739,54.4002616,13.719616,1296610.0838979,686715.864179483,212,251,2.32633586092875,0.754499729058273 +-133.68466,54.3902451,9.966558172,1300314.08471941,686715.867767179,213,251,2.32837960343874,0.761923185196732 +-158.6449,56.0663346,10.75855133,-288701.902865579,683011.755901349,66.2064743041992,20,1.82090046099715,-1.08138590911928 +-158.34782,56.0775729,13.719616,-270182.336998439,683011.779228446,83.9178771972656,20,1.92385448932785,-0.707427492216878 +-158.28838,56.0797316,13.719616,-266478.255931703,683011.777760942,97.7258758544922,20,1.99000957142527,-0.467133351498699 +-158.22893,56.0818606,13.719616,-262773.981450269,683011.76192856,92.7501907348633,20,1.96731481138696,-0.549567197687274 +-158.16948,56.0839599,13.719616,-259070.128208348,683011.77143847,95.0227584838867,20,1.97782763371254,-0.511381626342517 +-158.11002,56.0860295,13.719616,-255366.069794183,683011.766875658,81.2469711303711,20,1.90980717954771,-0.758451330839738 +-158.05056,56.0880694,13.719616,-251662.420858747,683011.786858754,90.8365707397461,20,1.95826073038128,-0.582454204191896 +-157.99108,56.0900796,13.719616,-247957.934454918,683011.755778225,113.723365783691,120,2.05584970469105,-0.227983194832392 +-157.93161,56.0920601,13.719616,-244254.466294853,683011.786395666,145.657638549805,120,2.1633332647484,0.162427774158283 +-157.87212,56.0940109,13.719616,-240550.148896155,683011.767464847,177.860565185547,120,2.2500796680346,0.477515470782309 +-157.81263,56.095932,13.719616,-236846.217435759,683011.772764235,182.631484985352,120,2.26157565039807,0.519272160006466 +-157.75313,56.0978234,13.719616,-233142.045492583,683011.766306102,161.353973388672,120,2.20777966449993,0.323869784321361 +-157.69363,56.0996851,13.719616,-229438.247708425,683011.783443527,96.9144821166992,21,1.98638867935643,-0.480285464998213 +-157.63412,56.101517,13.719616,-225734.198269083,683011.778198742,101.089973449707,21,2.00470808248115,-0.413744163970997 +-157.57461,56.1033192,13.719616,-222030.511183722,683011.79596781,121.853378295898,120,2.08583757418491,-0.119058693440584 +-157.51508,56.1050916,13.719616,-218325.940083185,683011.759039351,123.09627532959,120,2.09024491216545,-0.103049983915772 +-157.45556,56.1068343,13.719616,-214622.340058127,683011.778029906,153.149032592773,120,2.18511425781287,0.241542557882792 +-157.39603,56.1085473,13.719616,-210918.464146799,683011.786946617,148.959167480469,120,2.17306723641084,0.197784337588377 +-157.33649,56.1102305,13.719616,-207214.30701036,683011.775540316,159.917419433594,120,2.20389577301356,0.309762381869844 +-157.27695,56.111884,13.719616,-203510.482701045,683011.786488979,141.889205932617,120,2.15194935823262,0.121078176402549 +-157.2174,56.1135078,13.719616,-199806.364785327,683011.788946301,120.313034057617,120,2.08031267898297,-0.139126689776098 +-157.15784,56.1151017,13.719616,-196101.948420493,683011.761565526,101.088897705078,21,2.00470346093041,-0.413760950762424 +-157.09829,56.1166659,13.719616,-192398.467667153,683011.785500293,101.636116027832,21,2.00704806035403,-0.40524469644052 +-157.03872,56.1182004,13.719616,-188694.0550237,683011.773118977,98.5531921386719,21,1.99367069564498,-0.453835103343831 +-156.97915,56.119705,13.719616,-184989.946648153,683011.76049654,93.2120513916016,21,1.96947206594319,-0.541731433397275 +-156.91958,56.1211799,13.719616,-181286.135593093,683011.769215584,80.0684051513672,21,1.90346117806557,-0.781501819552017 +-156.86,56.1226251,13.719616,-177581.995417716,683011.771857897,80.5114669799805,21,1.9058577398892,-0.772796822961756 +-156.80042,56.1240404,13.719616,-173878.141684448,683011.773334752,75.4943389892578,21,1.87791438688875,-0.874295056886395 +-156.74083,56.125426,13.719616,-170173.946970242,683011.769648085,73.3987503051758,21,1.8656886656356,-0.918702366046094 +-156.68124,56.1267817,13.719616,-166470.026795349,683011.764619253,80.2050933837891,21,1.90420194881079,-0.778811128768363 +-156.62165,56.1281077,13.719616,-162766.374306702,683011.779903633,153.763641357422,121,2.18685365520161,0.247860545672161 +-156.56205,56.1294039,13.719616,-159062.363488092,683011.77979851,206.899856567383,121,2.31576018959268,0.716085872168523 +-156.50244,56.1306703,13.719616,-155357.98839443,683011.765379282,225.133148193359,220,2.35243944443447,0.849315395055569 +-156.44284,56.1319069,13.719616,-151654.484143965,683011.783406406,239.3115234375,220,2.37896361146269,0.945658740453046 +-156.38322,56.1331137,13.719616,-147949.983193133,683011.76480237,224.278945922852,220,2.35078850631283,0.843318716573095 +-156.32361,56.1342907,13.719616,-144246.341190423,683011.777517471,219.731323242188,220,2.34189197108339,0.811003961295806 +-156.26399,56.1354379,13.719616,-140542.311122553,683011.777010505,223.498168945312,220,2.34927396943572,0.837817486343583 +-156.20437,56.1365553,13.719616,-136838.507571839,683011.785030055,233.348068237305,220,2.36800420994647,0.90585106602153 +-156.14474,56.1376429,13.719616,-133134.30405538,683011.781013465,239.301528930664,220,2.37894547338999,0.945592857795889 +-156.08511,56.1387006,13.719616,-129430.315503755,683011.774477036,240.447219848633,220,2.38101975994433,0.953127258621585 +-156.02547,56.1397286,13.719616,-125725.914722341,683011.768289175,242.976760864258,220,2.3855647381619,0.969635916773719 +-155.96584,56.1407267,13.719616,-122022.337512235,683011.778107348,164.640930175781,220,2.21653781106916,0.355681872484695 +-155.9062,56.141695,13.719616,-118318.336505056,683011.777309738,63.3909111022949,121,1.8020269938268,-1.14993972890583 +-155.84655,56.1426335,13.719616,-114613.905745993,683011.767122546,64.9549942016602,22,1.81261254833958,-1.11148997349737 +-155.78691,56.1435422,13.719616,-110910.28034383,683011.782186765,63.2061805725098,22,1.8007595475434,-1.15454345557235 +-155.72726,56.144421,13.719616,-107206.21356792,683011.776977932,61.9191970825195,22,1.79182531613588,-1.18699513412797 +-155.66761,56.14527,13.719616,-103502.319683477,683011.779494007,56.036075592041,22,1.74846771247382,-1.34448232612074 +-155.60795,56.1460892,13.719616,-99797.9722006863,683011.774315594,55.5454864501953,22,1.74464877453856,-1.35835379873501 +-155.5483,56.1468785,13.719616,-96094.4064855094,683011.780529939,48.8201065063477,22,1.68859872254263,-1.56194358586183 +-155.48864,56.147638,13.719616,-92390.3752347321,683011.779421849,45.3983116149902,22,1.6570397015371,-1.67657495799531 +-155.42898,56.1483677,13.719616,-88686.4930209879,683011.785667886,37.2248306274414,22,1.57083273039373,-1.98970328310735 +-155.36931,56.1490675,13.719616,-84982.1335818807,683011.774987034,33.1068687438965,22,1.51991810701137,-2.1746397277124 +-155.30964,56.1497375,13.719616,-81277.9112389864,683011.77211501,34.7783432006836,22,1.54130888888178,-2.0969423024221 +-155.24998,56.1503776,13.719616,-77574.4407731163,683011.777275232,28.8561592102051,22,1.46023852548174,-2.39141300207651 +-155.19031,56.1509879,13.719616,-73870.4749283341,683011.777399927,32.3996391296387,22,1.51054017301898,-2.20870306070164 +-155.13063,56.1515684,13.719616,-70166.0077424205,683011.773880324,36.5160484313965,22,1.56248377441287,-2.02002907425912 +-155.07096,56.152119,13.719616,-66462.2744968422,683011.776988371,42.9755516052246,22,1.63322145970622,-1.76308961072815 +-155.01128,56.1526398,13.719616,-62758.027964302,683011.777044618,47.7179260253906,22,1.67868155957286,-1.59796555240817 +-154.95161,56.1531307,13.719616,-59054.5034053646,683011.782117308,37.0854339599609,22,1.56920336533012,-1.99562160208547 +-154.89193,56.1535918,13.719616,-55350.4536119621,683011.784785844,55.0940933227539,22,1.74110504032474,-1.37122565288205 +-154.83225,56.154023,13.719616,-51646.4932916752,683011.78313806,68.1370239257812,22,1.8333831606255,-1.03604518115192 +-154.77256,56.1544243,13.719616,-47941.9959176287,683011.769755235,93.3080291748047,22,1.9699190164826,-0.540107981465776 +-154.71288,56.1547958,13.719616,-44238.1964394269,683011.770596611,100.208755493164,22,2.00090566859956,-0.427555616505905 +-154.6532,56.1551375,13.719616,-40534.4683596185,683011.777713749,98.9829635620117,22,1.9955604524996,-0.446970967057552 +-154.59351,56.1554493,13.719616,-36830.1852801175,683011.774253384,92.4444046020508,122,1.9658806296759,-0.554776555018072 +-154.53382,56.1557313,13.719616,-33125.9616475855,683011.777882013,90.6265411376953,122,1.95725540497939,-0.586105833000002 +-154.47414,56.1559834,13.719616,-29422.4121077462,683011.78174991,97.7360610961914,122,1.99005483235269,-0.466968950891556 +-154.41445,56.1562056,13.719616,-25718.2895999356,683011.776321944,133.816223144531,122,2.1265087681033,0.0286706915854848 +-154.35476,56.156398,13.719616,-22014.2086002538,683011.77763309,120.653778076172,122,2.08154092568073,-0.134665347193355 +-154.29507,56.1565605,13.719616,-18310.163191631,683011.774444512,102.922340393066,122,2.01250965324991,-0.385406632148886 +-154.23538,56.1566932,13.719616,-14606.1473377348,683011.777830859,105.6396484375,122,2.02382694723095,-0.344298990132437 +-154.17569,56.156796,13.719616,-10902.1551012021,683011.776580872,122.038429260254,122,2.08649660926212,-0.116664889932799 +-154.116,56.1568689,13.719616,-7198.18048501099,683011.770646909,137.764175415039,122,2.13913629709035,0.0745374811220693 +-154.05631,56.156912,13.719616,-3494.21748261657,683011.771145188,158.284286499023,122,2.19943780288831,0.2935697619436 +-153.99662,56.1569253,13.719616,209.739873048129,683011.778055782,183.126022338867,134,2.26275006224366,0.523537959040156 +-153.93693,56.1569087,13.719616,3913.69755966752,683011.780222576,211.067321777344,134,2.3244209994358,0.747544405560004 +-153.87724,56.1568622,13.719616,7617.66157439403,683011.777653261,231.135696411133,134,2.36386702274956,0.89082362125154 +-153.81755,56.1567858,13.719616,11321.63791436,683011.770369365,249.703796386719,231,2.39742514522387,1.01271630052002 +-153.75786,56.1566797,13.719616,15025.6324953424,683011.780706097,272.745452880859,231,2.43575751891129,1.15195042290147 +-153.69817,56.1565436,13.719616,18729.6514062454,683011.775262799,285.346588134766,231,2.45537268409331,1.22319830156808 +-153.63848,56.1563777,13.719616,22433.7005526593,683011.77640228,228.074111938477,231,2.35807599250889,0.869788946492837 +-153.57879,56.1561819,13.719616,26137.7859720305,683011.773051458,163.658599853516,231,2.21393883134153,0.346241636291265 +-153.5191,56.1559563,13.719616,29841.9135802799,683011.776450719,159.996978759766,231,2.20411178190373,0.310546987814043 +-153.45941,56.1557008,13.719616,33546.0894345941,683011.775554743,264.673858642578,231,2.42271104894049,1.10456192013424 +-153.39973,56.1554155,13.719616,37249.6988983226,683011.77602236,483.145721435547,231,2.68407813793693,2.05392178896371 +-133.81044,54.3784768,13.719616,1292905.51690734,683011.688167064,274,351,2.43775056282039,1.15918972725066 +-133.75611,54.3684941,9.762371848,1296609.6464473,683011.729323137,222,251,2.34635297445064,0.827207598822789 +-158.64075,56.0331915,11.83798339,-288702.371764465,679307.786185867,106.971450805664,20,2.0292678859848,-0.324535947579919 +-158.5814,56.0354965,10.34175982,-284998.37539491,679307.783227208,60.8425140380859,20,1.78420715098106,-1.2146664844111 +-158.46268,56.0400177,5.839680651,-277590.499803568,679307.795864668,72.1872329711914,20,1.85846039507038,-0.944957507892781 +-158.4033,56.0422338,10.91084603,-273885.988555215,679307.759262102,61.6385841369629,20,1.78985265424226,-1.19416040517939 +-158.34392,56.0444203,13.719616,-270181.914826237,679307.757324707,124.15340423584,20,2.09395863223187,-0.0895606926332729 +-158.28454,56.0465771,13.719616,-266478.273493466,679307.777928255,95.1016540527344,20,1.97818807045717,-0.510072417207163 +-158.22515,56.0487043,13.719616,-262774.436884774,679307.791643253,103.406967163086,20,2.01454980083285,-0.377996233811556 +-158.16575,56.0508018,13.719616,-259070.399853778,679307.78804412,101.345985412598,20,2.00580654979579,-0.409754217150429 +-158.10634,56.0528696,13.719616,-255366.156523779,679307.767843316,91.7887954711914,20,1.96278967072174,-0.566003800187099 +-158.04693,56.0549078,13.719616,-251662.321427432,679307.780789215,79.5748138427734,120,1.90077563130623,-0.791256491913322 +-157.98751,56.0569163,13.719616,-247958.268293787,679307.777484439,119.00724029541,120,2.07557338428909,-0.156341160833681 +-157.92808,56.0588951,13.719616,-244253.991241396,679307.758681757,154.460815429688,120,2.18881832323626,0.254996780746073 +-157.86865,56.0608443,13.719616,-240550.104828105,679307.772498511,159.301071166992,120,2.20221869607954,0.303670759760066 +-157.80921,56.0627637,13.719616,-236845.983387607,679307.760118667,158.26383972168,120,2.19938169816458,0.293365973573107 +-157.74977,56.0646535,13.719616,-233142.240835625,679307.779701346,133.03173828125,120,2.12395526589971,0.0193956427399641 +-157.69032,56.0665135,13.719616,-229438.251463049,679307.773570542,96.2135314941406,21,1.98323615561339,-0.491736331052789 +-157.63086,56.0683439,13.719616,-225734.008132621,679307.764808803,94.073600769043,21,1.97346776743514,-0.527217905091792 +-157.5714,56.0701446,13.719616,-222030.126673061,679307.776551525,96.2916259765625,21,1.98358852024704,-0.490456442128511 +-157.51193,56.0719155,13.719616,-218325.980692012,679307.763964427,120.672622680664,120,2.08160875172658,-0.134418983635348 +-157.45246,56.0736567,13.719616,-214622.184777027,679307.771357466,149.632553100586,120,2.17502608613536,0.204899438899228 +-157.39298,56.0753682,13.719616,-210918.111943713,679307.766172112,152.510055541992,120,2.18329847923971,0.234947131830287 +-157.3335,56.07705,13.719616,-207214.377386157,679307.780497819,154.882553100586,120,2.19000249898006,0.259298045044957 +-157.27401,56.0787021,13.719616,-203510.354117324,679307.78291857,144.810684204102,120,2.16080060550551,0.153228432895187 +-157.21451,56.0803244,13.719616,-199806.036778222,679307.763213254,105.372299194336,120,2.02272645633953,-0.348296287161454 +-157.15501,56.081917,13.719616,-196102.039999691,679307.762973575,98.3746185302734,21,1.99288306129578,-0.456696016113357 +-157.09551,56.0834799,13.719616,-192398.357880794,679307.781468208,102.31282043457,21,2.00993005692948,-0.394776462274761 +-157.036,56.085013,13.719616,-188694.363938971,679307.778428949,104.200843811035,21,2.01787123586363,-0.365931833747824 +-156.97648,56.0865164,13.719616,-184990.051741409,679307.765961178,79.1349334716797,21,1.89836824158671,-0.800000818512026 +-156.91696,56.0879901,13.719616,-181286.036473484,679307.772345075,83.8349151611328,21,1.9234249291765,-0.70898777729525 +-156.85744,56.089434,13.719616,-177582.312709072,679307.785764854,77.1383514404297,21,1.88727035311992,-0.840311517076136 +-156.79791,56.0908481,13.719616,-173878.253421504,679307.779373559,76.0151596069336,21,1.88090021171635,-0.863449688873288 +-156.73838,56.0922325,13.22461616,-170174.473303219,679307.790957247,74.5956344604492,21,1.87271341212128,-0.893186481747848 +-156.6193,56.0949119,13.719616,-162766.486076448,679307.783078876,150.108276367188,121,2.17640463815605,0.209906733316278 +-156.55975,56.096207,13.719616,-159062.26665723,679307.775754448,198.314254760742,121,2.29735393226597,0.649229091889048 +-156.5002,56.0974723,13.719616,-155358.303144673,679307.775029655,220.971969604492,220,2.34433718672509,0.819885682440481 +-156.44064,56.0987079,13.719616,-151653.968096131,679307.768627474,221.646850585938,220,2.34566156472236,0.82469620134168 +-156.38109,56.0999137,13.719616,-147950.498176988,679307.791066819,214.87272644043,220,2.33218129446719,0.775732012122716 +-156.32152,56.1010897,13.719616,-144246.02417251,679307.774958176,214.712387084961,220,2.3318571002698,0.774554446263549 +-156.26196,56.1022359,13.719616,-140542.403406473,679307.786593418,219.124313354492,220,2.34069056820363,0.806640123122011 +-156.20239,56.1033523,13.719616,-136838.387752222,679307.782561569,224.305313110352,220,2.35083956081961,0.843504161114138 +-156.14281,56.1044389,13.719616,-133133.971262023,679307.764021218,229.332672119141,220,2.36046593135558,0.878469886540467 +-156.08324,56.1054958,13.719616,-129430.389817425,679307.782266945,240.475845336914,220,2.38107146007068,0.953315048237167 +-156.02366,56.1065229,13.719616,-125726.395658864,679307.786132128,236.925918579102,220,2.37461257309156,0.92985452717911 +-155.96407,56.1075201,13.719616,-122021.983165794,679307.765672,101.869216918945,121,2.0080429676967,-0.401630908997113 +-155.90449,56.1084876,13.719616,-118318.387897635,679307.780020522,67.0543823242188,121,1.82642716633426,-1.06131133785614 +-155.8449,56.1094253,13.719616,-114614.362062464,679307.781397615,63.1392097473145,22,1.80029914194441,-1.15621578012072 +-155.7853,56.1103332,13.719616,-110909.899707756,679307.771044057,60.0949859619141,22,1.77883823806076,-1.23416790857797 +-155.72571,56.1112112,13.719616,-107206.237349749,679307.771354359,56.8538017272949,22,1.75475951060656,-1.32162871944467 +-155.66611,56.1120595,13.719616,-103502.126265312,679307.771371048,54.9772453308105,22,1.74018297545653,-1.37457485566692 +-155.60651,56.112878,13.719616,-99798.1818894127,679307.776258057,50.6977577209473,22,1.70498875162221,-1.50241032206476 +-155.54691,56.1136667,13.719616,-96094.3982667805,679307.785637803,46.5430564880371,22,1.66785490005732,-1.63729107000488 +-155.4873,56.1144255,13.719616,-92390.1486012816,679307.774087963,38.4615821838379,22,1.58502714572609,-1.93814511513071 +-155.42769,56.1151545,13.719616,-88686.0477566333,679307.767431896,32.6797294616699,22,1.51427845257916,-2.19512456232784 +-155.36808,56.1158538,13.719616,-84982.089546082,679307.776480287,37.1099243164062,22,1.56949006863063,-1.99458021386474 +-155.30847,56.1165232,13.719616,-81278.2684813231,679307.778616597,32.3183555603027,22,1.50944925466271,-2.21266558755068 +-155.24885,56.1171628,13.719616,-77573.9572745974,679307.772997864,30.9510154724121,22,1.4906749023652,-2.28085939382892 +-155.18924,56.1177726,13.719616,-73870.3921470294,679307.783248471,34.6059608459473,22,1.53915091207409,-2.1047806901355 +-155.12962,56.1183525,13.719616,-70166.3251492656,679307.775135077,40.7979278564453,22,1.61063810565447,-1.8451187985751 +-155.07,56.1189027,13.719616,-66462.37102229,679307.782366421,48.3208465576172,22,1.68413453430681,-1.57815879174053 +-155.01037,56.119423,13.719616,-62757.9030853766,679307.772942796,53.5442161560059,22,1.72871256522963,-1.41623865959206 +-154.95075,56.1199135,13.719616,-59054.1573682011,679307.777229518,52.5537910461426,22,1.72060404997482,-1.44569110139818 +-154.89113,56.1203742,13.719616,-55350.5068199583,679307.784992515,70.9265670776367,22,1.85080894003577,-0.972749776521198 +-154.8315,56.120805,13.719616,-51646.3245290684,679307.777093738,100.520133972168,22,2.002253058744,-0.422661510917869 +-154.77187,56.121206,13.719616,-47942.225464205,679307.773374888,107.910400390625,22,2.03306330394691,-0.310749906221406 +-154.71224,56.1215772,13.719616,-44238.2036634293,679307.773650847,112.644668579102,22,2.05171064158609,-0.243017453435853 +-154.65261,56.1219186,13.719616,-40534.2531644944,679307.777750256,107.573028564453,122,2.031703395736,-0.315689480999856 +-154.59298,56.1222301,13.719616,-36830.3681044316,679307.774366428,94.2086639404297,122,1.97409084470897,-0.524954710589279 +-154.53334,56.1225118,13.719616,-33125.9213109828,679307.769516373,95.0876693725586,122,1.97812420284007,-0.5103044026221 +-154.47371,56.1227637,13.719616,-29422.1490009542,679307.773603854,154.202194213867,122,2.18809055353462,0.252353313463567 +-154.41408,56.1229858,13.719616,-25718.4241212172,679307.780966805,142.302963256836,122,2.15321394374341,0.125671511926369 +-154.35444,56.123178,13.719616,-22014.1196779707,679307.777038461,106.239685058594,122,2.02628677458496,-0.335364195078048 +-154.29481,56.1233404,13.719616,-18310.4718079321,679307.780066759,92.4000701904297,122,1.965672301126,-0.555533263774173 +-154.23517,56.1234729,13.719616,-14606.2324070677,679307.772755303,95.9518814086914,122,1.98205349472967,-0.496032092947502 +-154.17553,56.1235757,13.719616,-10902.0165124889,679307.780656599,110.940032958984,122,2.04508829056664,-0.267071722545646 +-154.1159,56.1236485,13.719616,-7198.43933859936,679307.771358649,130.448364257812,122,2.11543863768492,-0.0115391818238581 +-154.05626,56.1236916,13.719616,-3494.25265319784,679307.775550736,143.533309936523,122,2.15695269997515,0.139251741707324 +-153.99662,56.1237048,13.719616,209.928388931401,679307.772555596,161.838409423828,134,2.20908160146165,0.328598790976139 +-153.93699,56.1236882,13.719616,3913.48868138468,679307.772927303,182.913345336914,134,2.26224539270848,0.521704855241388 +-153.87735,56.1236418,13.719616,7617.67636802616,679307.777294423,212.881088256836,134,2.32813708168017,0.761042276947025 +-153.81771,56.1235655,13.719616,11321.8763535689,679307.774497328,246.826049804688,231,2.39239099283856,0.99443082216643 +-153.75807,56.1234594,13.719616,15026.0945914085,679307.775720774,275.671447753906,231,2.44039178705223,1.16878340754116 +-153.69844,56.1233235,13.719616,18729.7159555405,679307.77819344,304.429840087891,231,2.48348721955173,1.32531831904042 +-153.6388,56.1231577,13.719616,22433.9886502245,679307.775911592,336.885009765625,231,2.52748168678727,1.48511878131101 +-153.57917,56.1229621,13.719616,26137.6764187197,679307.773902895,330.434661865234,231,2.51908559756856,1.45462178878622 +-153.51953,56.1227367,13.719616,29842.0274043898,679307.779571444,347.994537353516,330,2.54157242665967,1.53630037042516 +-153.4599,56.1224814,13.719616,33545.8054814789,679307.773442913,419.143341064453,330,2.62236257090763,1.82975323413671 +-153.40027,56.1221963,13.719616,37249.6376324365,679307.770720228,646.200988769531,330,2.81036761820781,2.51264122791397 +-133.82747,54.3466974,9.236973568,1292905.82660322,679307.78231877,429,351,2.63245729218472,1.86642014313543 +-158.75517,55.995352,10.58455485,-296110.234504666,675603.781870441,66.0130081176758,20,1.81962952337636,-1.0860023173197 +-158.6366,56.0000469,7.939702999,-288702.379673046,675603.788858388,13.1513528823853,20,1.11897043108683,-3.63099612853068 +-158.5773,56.00235,13.70163849,-284998.212721156,675603.780910273,200.677627563477,20,2.30249895810127,0.667917294259438 +-158.45868,56.0068673,8.431984885,-277589.993777307,675603.764801465,40.3968162536621,20,1.6063471389237,-1.86070481450507 +-158.39936,56.0090815,10.89148924,-273885.930095872,675603.75680967,50.7720603942871,20,1.70562478798039,-1.50010005646899 +-158.34004,56.0112661,13.719616,-270182.303334665,675603.779824735,83.8356323242188,20,1.92342864431879,-0.708974282838047 +-158.28071,56.0134211,13.719616,-266478.486006977,675603.792724114,127.886650085449,20,2.10682521143077,-0.042825604495555 +-158.22137,56.0155465,13.719616,-262774.472272071,675603.796197384,125.32886505127,20,2.09805110681835,-0.074695656826649 +-158.16202,56.0176422,13.719616,-259070.256985779,675603.779821323,108.336769104004,20,2.03477587960613,-0.304529342609363 +-158.10267,56.0197083,13.719616,-255366.455233673,675603.793889456,95.2379760742188,20,1.97881015753147,-0.507812819391942 +-158.04331,56.0217447,13.719616,-251662.440200837,675603.788436175,83.1653594970703,20,1.91994246917557,-0.721637066011677 +-157.98394,56.0237515,13.719616,-247958.205341908,675603.7753307,119.290374755859,120,2.07660540294061,-0.152592574523908 +-157.92457,56.0257286,13.719616,-244254.367114235,675603.78097998,133.287399291992,120,2.12478909407535,0.0224243446721565 +-157.86519,56.0276761,13.719616,-240550.297341619,675603.779386688,127.442184448242,120,2.10531320696827,-0.048317636272384 +-157.8058,56.0295939,13.719616,-236845.990810826,675603.760204199,142.051467895508,120,2.15244572588455,0.122881125391782 +-157.74641,56.0314821,13.719616,-233142.062657848,675603.770463836,108.119575500488,120,2.0339043319013,-0.30769505263779 +-157.68702,56.0333406,13.719616,-229438.507646599,675603.798171413,73.307502746582,21,1.86514842531905,-0.920664673075753 +-157.62761,56.0351693,13.719616,-225734.077204454,675603.763362932,93.7028198242188,21,1.97175266042536,-0.533447663291579 +-157.5682,56.0369685,13.719616,-222030.006913303,675603.768807313,96.0981750488281,21,1.98271514028302,-0.493628807445296 +-157.50879,56.0387379,13.719616,-218326.292710295,675603.780285123,121.036087036133,21,2.08291487497808,-0.129674771181195 +-157.44937,56.0404776,13.719616,-214622.306448927,675603.775799816,136.235168457031,120,2.1342892330927,0.0569315611927981 +-157.38994,56.0421877,13.719616,-210918.041668822,675603.76736102,136.294250488281,120,2.1344775357035,0.0576155300221367 +-157.33051,56.0438681,13.719616,-207214.114713483,675603.775926927,142.630249023438,120,2.15421164045847,0.129295431166463 +-157.27108,56.0455187,13.719616,-203510.520237604,675603.789592174,106.646278381348,120,2.02794570454264,-0.329338487966008 +-157.21163,56.0471397,13.719616,-199806.007942663,675603.76969651,90.6471481323242,21,1.95735414522273,-0.585747180252933 +-157.15219,56.0487309,13.719616,-196102.437962666,675603.785158287,106.691925048828,21,2.02813155120102,-0.32866343985684 +-157.09273,56.0502925,13.719616,-192397.938388799,675603.768933291,113.622665405273,21,2.05546497291189,-0.229380650467698 +-157.03328,56.0518243,13.719616,-188694.369312745,675603.786618478,79.0840148925781,21,1.89808870921815,-0.801016159861114 +-156.97382,56.0533264,13.719616,-184990.481009843,675603.791263081,81.0768127441406,21,1.90889666756365,-0.761758570251828 +-156.91435,56.0547988,13.719616,-181286.267578515,675603.783851044,89.6946105957031,21,1.95276634874238,-0.602411366557059 +-156.85488,56.0562414,13.719616,-177582.345242782,675603.780981477,82.6112289428711,21,1.917039082871,-0.732182993778847 +-156.7954,56.0576543,13.719616,-173878.085952084,675603.766947474,78.3593139648438,21,1.89409062509469,-0.815538342564368 +-156.73592,56.0590375,12.84252079,-170174.105449105,675603.768398081,67.3868179321289,21,1.82857494906876,-1.05350997792623 +-156.67644,56.060391,10.71429084,-166470.397827797,675603.784698295,42.923583984375,21,1.63269597703235,-1.76499831378731 +-156.61695,56.0617147,13.33936108,-162766.335972609,675603.779577801,138.291320800781,21,2.14079492453008,0.0805620894025773 +-156.55745,56.0630087,13.719616,-159061.913516242,675603.765241147,193.213073730469,121,2.28603650953755,0.608120982225377 +-156.49796,56.0642729,13.719616,-155358.368264073,675603.778413348,213.187042236328,220,2.32876080421814,0.76330781523305 +-156.43846,56.0655074,13.719616,-151654.450571454,675603.782309224,212.282775878906,220,2.32691475797096,0.756602448349237 +-156.37895,56.0667122,13.719616,-147950.154527273,675603.778034929,210.573333740234,220,2.32340337281942,0.743848095229758 +-156.31944,56.0678872,13.719616,-144246.096256405,675603.777288545,212.150115966797,220,2.32664327349941,0.755616339259194 +-156.25993,56.0690324,13.719616,-140542.269815919,675603.779529139,214.542816162109,220,2.33151397702116,0.77330812468737 +-156.20041,56.0701479,13.719616,-136838.047244999,675603.774767397,216.558563232422,220,2.33557536142563,0.788060232078949 +-156.14089,56.0712336,13.719616,-133134.044635873,675603.773067961,218.768051147461,220,2.33998389799285,0.804073295212673 +-156.08137,56.0722895,13.719616,-129430.256042961,675603.773930879,222.421295166016,220,2.34717636533064,0.830198389518121 +-156.02184,56.0733157,13.719616,-125726.053532846,675603.769082047,197.585098266602,121,2.29575418729297,0.643418361534434 +-155.96231,56.0743121,13.719616,-122022.053165293,675603.766952817,78.0454635620117,121,1.89234766451256,-0.821869272889139 +-155.90278,56.0752788,13.719616,-118318.248672907,675603.778228521,71.2014541625977,22,1.85248886341695,-0.966647815302867 +-155.84324,56.0762157,13.719616,-114614.01279864,675603.774061941,66.2792129516602,22,1.8213773426444,-1.07965373886091 +-155.7837,56.0771228,13.719616,-110909.961240621,675603.772395245,60.0089416503906,22,1.77821596738519,-1.23642817328537 +-155.72416,56.0780001,13.719616,-107206.088048623,675603.772810521,55.2173919677734,22,1.74207589015632,-1.36769924918563 +-155.66462,56.0788476,13.719616,-103502.387271716,675603.774903605,52.2686614990234,22,1.71824137878474,-1.45427299753406 +-155.60507,56.0796654,13.719616,-99798.2310412283,675603.774402248,50.4245834350586,22,1.70264231912868,-1.51093323461978 +-155.54552,56.0804534,13.719616,-96094.2353419719,675603.775927348,40.4019737243652,22,1.60640258185968,-1.8605034299366 +-155.48597,56.0812116,13.719616,-92390.3942210738,675603.779115767,35.5950584411621,22,1.55138971031287,-2.06032588163147 +-155.42641,56.08194,13.719616,-88686.0800774114,675603.770263945,35.1954574584961,22,1.54648661438681,-2.0781353255178 +-155.36685,56.0826387,13.719616,-84981.9083751267,675603.774652392,36.3387641906738,22,1.56037015372884,-2.02770634787092 +-155.3073,56.0833075,13.719616,-81278.4952761462,675603.781904781,39.9302558898926,22,1.60130209334516,-1.87902986004573 +-155.24773,56.0839465,13.719616,-77573.9696429428,675603.766143224,32.5515823364258,22,1.51257210452558,-2.20132250549866 +-155.18817,56.0845558,13.719616,-73870.1902633402,675603.774936352,38.4007263183594,22,1.58433943877046,-1.94064306308467 +-155.1286,56.0851353,13.719616,-70165.9081053556,675603.774052396,48.2354583740234,22,1.68336640991249,-1.58094883878522 +-155.06904,56.0856849,13.719616,-66462.3606871358,675603.773765251,56.2087554931641,22,1.74980396977195,-1.33962865820815 +-155.00947,56.0862048,13.719616,-62758.2983874243,675603.775543327,52.1545219421387,22,1.71729196893475,-1.45772152509779 +-154.9499,56.0866949,13.719616,-59054.3370858639,675603.778564978,70.1585845947266,22,1.84608081882862,-0.989923662285731 +-154.89033,56.0871552,13.719616,-55350.4708245937,675603.782604251,100.976593017578,22,2.00422071337247,-0.415514427682729 +-154.83075,56.0875857,13.719616,-51646.0719977415,675603.779672153,116.535087585449,22,2.066456706911,-0.189455535229664 +-154.77118,56.0879863,13.719616,-47942.3780714847,675603.774533163,125.171058654785,122,2.09750392536412,-0.0766831760495289 +-154.7116,56.0883572,13.719616,-44238.1395227082,675603.774303174,136.746109008789,122,2.13591497771075,0.0628367296792636 +-154.65202,56.0886983,13.719616,-40533.9721793164,675603.775439781,109.759010314941,122,2.04044018239422,-0.283954978130022 +-154.59245,56.0890096,13.719616,-36830.4917294788,675603.78333148,114.090858459473,122,2.05725084792693,-0.222893842673593 +-154.53287,56.089291,13.719616,-33126.4490076236,675603.775036689,163.486953735352,122,2.21348310166413,0.344586296024764 +-154.47329,56.0895427,13.719616,-29422.4595125175,675603.778826433,155.7265625,122,2.19236269711063,0.267870958322805 +-154.41371,56.0897645,13.719616,-25718.5174529003,675603.772287224,126.420433044434,122,2.10181727363995,-0.0610158639595701 +-154.35412,56.0899566,13.719616,-22013.9950718579,675603.774299478,97.8211288452148,122,1.99043267022539,-0.465596535892252 +-154.29454,56.0901189,13.719616,-18310.1297836192,675603.780813277,87.2560577392578,122,1.94079558750981,-0.645892588149155 +-154.23496,56.0902513,13.719616,-14606.2940193221,675603.776732212,89.5226974487305,122,1.95193315964015,-0.605437747192196 +-154.17538,56.0903539,13.719616,-10902.4817587472,675603.773144111,101.171020507812,122,2.00505613072619,-0.412479953402148 +-154.11579,56.0904268,13.719616,-7198.0653739418,675603.780066788,122.655158996582,122,2.08868581977948,-0.108713052470857 +-154.05621,56.0904698,13.719616,-3494.28224814483,675603.777894112,135.047454833984,122,2.13048640368843,0.043118599360923 +-153.99663,56.090483,13.719616,209.495256705692,675603.776113661,142.919525146484,134,2.15509156457907,0.13249156672785 +-153.93704,56.0904664,13.719616,3913.89474926334,675603.775308621,157.921768188477,134,2.1984419979788,0.28995271428123 +-153.87746,56.09042,13.719616,7617.67889522826,675603.774865789,183.02278137207,134,2.26250515097851,0.522648371420507 +-153.81787,56.0903438,13.719616,11322.0969508744,675603.77654293,204.905883789062,134,2.31155442916955,0.700809349868172 +-153.75829,56.0902378,13.719616,15025.9115818326,675603.777523296,231.16618347168,231,2.36392430290679,0.891031679131991 +-153.69871,56.090102,13.719616,18729.750396602,675603.779002882,259.465789794922,231,2.41408010483301,1.07321186761917 +-153.63913,56.0899363,13.719616,22433.6194165327,675603.769895421,286.673980712891,231,2.45738827702179,1.23051951039183 +-153.57955,56.0897409,13.719616,26137.5244911012,675603.772575122,327.960968017578,231,2.51582215961634,1.44276805066584 +-153.51996,56.0895157,13.719616,29842.0932790379,675603.780476673,365.061920166016,330,2.56236653378709,1.61183050274103 +-153.46038,56.0892606,13.719616,33546.0885359805,675603.774125992,439.594818115234,430,2.64305256437651,1.90490519592777 +-153.40081,56.0889758,13.719616,37249.5160508991,675603.774264919,572.392761230469,430,2.75769413281391,2.32131609445376 +-158.86936,55.9574006,11.32112323,-303518.304756876,671899.784647802,82.0774917602539,20,1.91422407618727,-0.742407901537046 +-158.81014,55.95982,13.719616,-299813.967405188,671899.762501458,139.443603515625,20,2.14439859732863,0.0936516575975283 +-158.63245,55.9669007,12.95189176,-288701.927301567,671899.753736766,57.5896987915039,20,1.76034480706733,-1.30134132849682 +-158.57321,55.9692018,13.719616,-284998.218259052,671899.772954411,133.715637207031,20,2.1261821982539,0.0274844966801669 +-158.51396,55.9714734,12.57118147,-281294.340074199,671899.789115313,62.2341842651367,20,1.79402900140499,-1.17899072023616 +-158.4547,55.9737153,13.719616,-277590.288440029,671899.780615189,62.6808891296387,20,1.79713514831597,-1.16770830807291 +-158.39543,55.9759277,13.719616,-273886.056019427,671899.770349612,63.2250595092773,20,1.80088924678732,-1.15407235089858 +-158.33616,55.9781104,13.719616,-270182.26066768,671899.777421397,80.2372360229492,20,1.90437595988454,-0.778179070880784 +-158.27688,55.9802636,13.719616,-266478.272878599,671899.782956718,126.439590454102,20,2.10188308046229,-0.0607768347976755 +-158.21759,55.9823871,13.719616,-262774.088259042,671899.765398995,156.449432373047,120,2.19437399178582,0.275176554663759 +-158.1583,55.9844811,13.719616,-259070.321750006,671899.786712612,141.580017089844,20,2.15100196041566,0.117636957117104 +-158.099,55.9865454,13.719616,-255366.346709993,671899.785239447,96.1629791259766,20,1.98300790929605,-0.492565386825362 +-158.03969,55.9885801,13.719616,-251662.156588808,671899.77283609,81.0097122192383,20,1.90853708937701,-0.763064660859541 +-157.98038,55.9905852,13.719616,-247958.36774754,671899.787584347,107.62629699707,120,2.03191839814605,-0.314908530878781 +-157.92106,55.9925606,13.719616,-244254.352792772,671899.780661872,97.2041397094727,120,1.98768476096225,-0.47557772666736 +-157.86173,55.9945065,13.719616,-240550.104551591,671899.775096182,116.491661071777,120,2.06629483797894,-0.190043489392931 +-157.8024,55.9964226,13.719616,-236846.2413241,671899.773949424,129.476623535156,120,2.11219136543574,-0.0233342014966425 +-157.74306,55.9983092,13.719616,-233142.133110978,671899.774627438,91.3639144897461,120,1.96077469866093,-0.573322753842235 +-157.68372,56.0001661,13.719616,-229438.39753169,671899.790230731,74.121208190918,21,1.86994248979381,-0.903251262541163 +-157.62437,56.0019933,13.719616,-225734.406497777,671899.785919124,97.7848587036133,21,1.99027161255294,-0.466181543329026 +-157.56501,56.0037909,13.719616,-222030.153526595,671899.773661336,101.168449401855,21,2.00504509365933,-0.412520043179302 +-157.50565,56.0055588,13.719616,-218326.25555566,671899.776052084,137.050369262695,21,2.1368802100217,0.0663427289373914 +-157.44628,56.0072971,13.719616,-214622.083914077,671899.771097651,112.700881958008,21,2.05192731469737,-0.242230434851004 +-157.38691,56.0090057,13.719616,-210918.255516746,671899.780303069,133.680374145508,21,2.12606765239328,0.027068433419749 +-157.32753,56.0106846,13.719616,-207214.14226833,671899.771684128,125.287063598633,21,2.09790623062886,-0.0752218884986548 +-157.26815,56.0123339,13.719616,-203510.359934573,671899.78792362,107.631065368652,21,2.03193763909041,-0.314838642276956 +-157.20876,56.0139534,13.719616,-199806.281524259,671899.775911384,114.82893371582,21,2.06005133205044,-0.212721684999257 +-157.14936,56.0155433,13.719616,-196101.900056774,671899.758848142,111.583869934082,21,2.0476014194679,-0.25794332105787 +-157.08997,56.0171035,13.719616,-192398.454596228,671899.784485769,106.747344970703,21,2.02835708202107,-0.327844247545529 +-157.03056,56.018634,13.719616,-188694.072630202,671899.765196921,81.9307174682617,21,1.91344675799796,-0.745231343069306 +-156.97115,56.0201349,13.719616,-184989.992173425,671899.770474204,101.094749450684,21,2.00472860026153,-0.413669637536309 +-156.91174,56.021606,13.719616,-181286.208334404,671899.77735633,92.8547439575195,21,1.96780409678816,-0.547789973454166 +-156.85232,56.0230474,13.719616,-177582.092499429,671899.769565549,87.0687866210938,21,1.93986249223216,-0.649281856529494 +-156.7929,56.0244591,13.719616,-173878.260972986,671899.774296356,81.6738204956055,21,1.91208287126564,-0.750185368973125 +-156.6146,56.0285161,13.6973103,-162765.923959094,671899.77031723,165.699981689453,21,2.21932246042797,0.365796513773948 +-156.55516,56.0298089,13.719616,-159061.926664068,671899.76198618,193.383056640625,121,2.28641842047176,0.609508191746662 +-156.49572,56.0310721,13.719616,-155358.183718191,671899.776446344,199.137313842773,121,2.29915264464658,0.655762528659028 +-156.43627,56.0323055,13.719616,-151654.067856569,671899.768002276,205.284393310547,220,2.31235593350723,0.703720642394767 +-156.37682,56.0335092,13.719616,-147950.194947625,671899.771179172,208.325866699219,220,2.31874319729911,0.726921007593452 +-156.31736,56.0346832,13.719616,-144245.936876885,671899.763704539,209.428253173828,220,2.32103527032176,0.735246471034502 +-156.2579,56.0358275,13.719616,-140541.909939726,671899.767875302,211.826400756836,220,2.32598008697295,0.753207456502808 +-156.19844,56.036942,13.719616,-136838.108594227,671899.772024109,210.51823425293,220,2.32328971866319,0.743435270894191 +-156.13897,56.0380268,13.719616,-133133.90433429,671899.766733958,208.756851196289,220,2.31964073751093,0.730181129826268 +-156.0795,56.0390818,13.719616,-129429.913801694,671899.76152648,204.621688842773,121,2.31095166478922,0.698619937592764 +-156.02003,56.0401072,13.719616,-125726.130374952,671899.77820275,116.458000183105,121,2.06616932813076,-0.190499376985569 +-155.96055,56.0411027,13.719616,-122021.92695155,671899.76448873,73.3892669677734,121,1.8656325498683,-0.918906194529949 +-155.90107,56.0420686,13.719616,-118317.918804684,671899.772846136,69.3507461547852,22,1.84105113807207,-1.00819289840733 +-155.84159,56.0430046,13.719616,-114614.100975804,671899.76940005,66.7811279296875,22,1.82465374999093,-1.06775289219856 +-155.78211,56.043911,13.719616,-110910.466591099,671899.787152084,57.0886573791504,22,1.75654982931457,-1.31512577088934 +-155.72262,56.0447875,13.719616,-107206.3884253,671899.776110018,51.9606552124023,22,1.71567461879315,-1.46359620244975 +-155.66313,56.0456344,13.719616,-103502.481868457,671899.786562721,46.9781455993652,22,1.67189586957531,-1.62261311530804 +-155.60363,56.0464514,13.719616,-99798.119634049,671899.769659107,40.0613746643066,22,1.60272584757563,-1.87385837830074 +-155.54413,56.0472388,13.719616,-96093.917170706,671899.774601521,34.2543144226074,22,1.53471527982627,-2.1208921725151 +-155.48464,56.0479963,13.719616,-92390.4915415027,671899.781503824,28.9572505950928,22,1.46175732451186,-2.3858962904907 +-155.42513,56.0487241,13.719616,-88685.9696714382,671899.770572796,32.7346267700195,22,1.51500739359634,-2.19247684049297 +-155.36563,56.0494221,13.719616,-84982.2124848365,671899.772063554,34.0243873596191,22,1.53179031407428,-2.13151648299466 +-155.30612,56.0500904,13.719616,-81277.9694001015,671899.770650588,42.6325531005859,22,1.62974134166179,-1.77573039279011 +-155.24662,56.0507289,13.719616,-77574.4791151148,671899.77991533,34.8548164367676,22,1.5422627998624,-2.09347742546716 +-155.18711,56.0513376,13.719616,-73870.491266484,671899.775644211,45.2605857849121,22,1.65572017050931,-1.68136787131991 +-155.12759,56.0519166,13.719616,-70165.9997118254,671899.770377065,53.2037010192871,22,1.72594184425646,-1.42630270900912 +-155.06808,56.0524658,13.719616,-66462.243117596,671899.774389372,54.6691970825195,22,1.73774269552697,-1.38343864889631 +-155.00856,56.0529852,13.719616,-62757.9711190176,671899.766855089,68.1763916015625,22,1.83363401142792,-1.0351340194376 +-154.94905,56.0534749,13.719616,-59054.4220131291,671899.778140071,98.9677276611328,22,1.99549359880335,-0.447213798764271 +-154.88953,56.0539348,13.719616,-55350.3456136309,671899.778529526,121.20238494873,22,2.08351116570389,-0.127508873066749 +-154.83001,56.0543649,13.719616,-51646.3581707233,671899.777261617,142.703140258789,122,2.15443353010174,0.130101397684441 +-154.77049,56.0547652,13.719616,-47942.4537288727,671899.774138244,159.495712280273,122,2.20274901242112,0.305597020080051 +-154.71096,56.0551358,13.719616,-44238.0040074887,671899.773461684,144.511749267578,122,2.15990315805893,0.149968647612201 +-154.65144,56.0554766,13.719616,-40534.2476005145,671899.777793826,144.796859741211,122,2.16075914327099,0.153077830224902 +-154.59191,56.0557876,13.719616,-36829.9341407453,671899.774212912,216.072982788086,122,2.33460046720911,0.784519138022036 +-154.53239,56.0560688,13.719616,-33126.3020822585,671899.774224995,190.474151611328,122,2.27983604786343,0.585599135636995 +-154.47286,56.0563203,13.719616,-29422.1009779912,671899.778315004,160.858535766602,122,2.20644411116884,0.319018673417957 +-154.41333,56.0565419,13.719616,-25717.9472449491,671899.769616387,167.924835205078,122,2.22511493077117,0.386836419396117 +-154.35381,56.0567338,13.719616,-22014.4569824401,671899.773638513,153.861679077148,122,2.18713046753993,0.248866007095026 +-154.29428,56.0568959,13.719616,-18310.3799015981,671899.771957287,126.69864654541,122,2.10277197557011,-0.0575481140501674 +-154.23475,56.0570283,13.719616,-14606.3322107927,671899.779519124,119.8203125,122,2.07853044792709,-0.145600261670447 +-154.17522,56.0571308,13.719616,-10902.3080411059,671899.773966074,123.594696044922,122,2.0919998337961,-0.0966756076487357 +-154.11569,56.0572036,13.719616,-7198.30136589762,671899.777547947,130.901382446289,122,2.11694423314835,-0.00607042936096222 +-154.05616,56.0572466,13.719616,-3494.3062666903,671899.779082699,130.346267700195,122,2.11509860021155,-0.0127742949834914 +-153.99663,56.0572598,13.719616,209.683214446901,671899.778550517,134.862487792969,134,2.12989116679541,0.0409565290679552 +-153.9371,56.0572432,13.719616,3913.67303546826,671899.775945329,119.147758483887,134,2.07608587641612,-0.154479643148475 +-153.87757,56.0571968,13.719616,7617.669154322,671899.771274772,121.545402526855,134,2.08473853623588,-0.123050712968102 +-153.81804,56.0571207,13.719616,11321.6774983905,671899.775708758,150.651962280273,134,2.17797479284273,0.215609983305065 +-153.75851,56.0570148,13.719616,15025.7040361121,671899.778133781,134.12434387207,231,2.12750761043767,0.0322987720419184 +-153.69898,56.0568791,13.719616,18729.754725295,671899.778598611,80.841423034668,134,1.90763394970552,-0.766345121928129 +-153.63945,56.0567136,13.719616,22433.8355236531,671899.777165775,72.1410903930664,231,1.85818270227557,-0.945966167384975 +-153.57992,56.0565183,13.719616,26137.9523887864,671899.773911515,155.752944946289,330,2.19243626696415,0.268138185029745 +-153.5204,56.0562933,13.719616,29841.4889922473,671899.775580584,277.479431152344,330,2.44323079550152,1.17909549656267 +-153.46087,56.0560385,13.719616,33545.6957626273,671899.779557441,435.440795898438,430,2.63892911511295,1.88992765125291 +-153.40134,56.0557539,13.719616,37249.9564516462,671899.782023753,694.426818847656,430,2.84162648499769,2.62618235426367 +-159.10158,55.9142964,8.503410441,-318334.003892955,668195.762467565,25.6655769348145,12,1.40935103118358,-2.57625090610435 +-158.98331,55.9193377,9.780014076,-310925.95710714,668195.758800289,51.9367942810059,20,1.71547513995953,-1.4643207665104 +-158.92417,55.9218141,9.938916472,-307222.364779697,668195.791696945,33.686595916748,20,1.52745712706109,-2.14725585504127 +-158.86501,55.9242609,13.41887237,-303518.014992614,668195.75970042,77.0942687988281,20,1.88702209372464,-0.841213266060083 +-158.80585,55.9266782,13.58574675,-299814.14664873,668195.76645288,135.927978515625,20,2.13330885823603,0.0533705598865233 +-158.74668,55.929066,13.719616,-296110.131195299,668195.766270027,134.84260559082,20,2.12982713588974,0.0407239505423166 +-158.6875,55.9314243,13.719616,-292405.962840875,668195.759741457,68.8522338867188,20,1.83791803535455,-1.0195732217539 +-158.62832,55.933753,13.719616,-288702.259331549,668195.779822172,80.4717483520508,20,1.90564343703467,-0.773575232097539 +-158.56913,55.9360522,13.719616,-284998.391313136,668195.793659013,104.517784118652,20,2.01919019367638,-0.361141002503848 +-158.50993,55.9383218,13.719616,-281294.353745243,668195.790759978,99.9367141723633,20,1.99972506613648,-0.431843901629304 +-158.45072,55.9405618,13.719616,-277590.140799609,668195.771765402,78.1139450073242,20,1.89272857163805,-0.820485709487625 +-158.39151,55.9427723,13.719616,-273886.368672799,668195.789692544,68.7792205810547,20,1.83745725000788,-1.02124692565425 +-158.33229,55.9449532,13.719616,-270182.409526402,668195.791730541,66.6338729858398,20,1.82369505666444,-1.07123513999868 +-158.27306,55.9471045,13.719616,-266478.257527058,668195.778559527,121.975326538086,120,2.08627198942828,-0.117480773282204 +-158.21382,55.9492263,13.719616,-262773.906132933,668195.761997623,166.917053222656,120,2.22250070901094,0.377340819789754 +-158.15458,55.9513184,13.719616,-259069.973694045,668195.759513085,160.469711303711,120,2.20539307128909,0.315200996578041 +-158.09534,55.953381,13.719616,-255366.452968422,668195.792402702,105.032012939453,20,2.02132168882202,-0.353398803745595 +-158.03608,55.955414,13.719616,-251662.09329679,668195.772812762,71.2635879516602,20,1.85286768425665,-0.965271829886859 +-157.97682,55.9574173,13.719616,-247958.135031081,668195.766709808,81.2654418945312,20,1.90990590124947,-0.758092745440951 +-157.91755,55.9593911,13.719616,-244253.948221054,668195.758655303,99.2219848632812,120,1.99660791053073,-0.443166300514193 +-157.85828,55.9613353,13.719616,-240550.150462389,668195.774517511,108.58472442627,120,2.03576873350333,-0.300923013866011 +-157.799,55.9632498,13.719616,-236846.113783299,668195.766617296,105.585418701172,120,2.02360394646614,-0.345108992560994 +-157.73972,55.9651348,13.719616,-233142.453814858,668195.793118199,81.7084350585938,21,1.91226689264389,-0.749516950802395 +-157.68042,55.9669901,13.719616,-229437.920446617,668195.761805479,79.3888778686523,21,1.89975966340179,-0.794946777328328 +-157.62113,55.9688158,13.719616,-225734.375480263,668195.788279669,77.6106796264648,21,1.88992148651224,-0.830681843886437 +-157.56182,55.9706118,13.719616,-222029.945372238,668195.758605154,80.2919921875,21,1.90467223366972,-0.777102919928058 +-157.50252,55.9723783,13.719616,-218326.491353654,668195.796195881,105.697875976562,21,2.02406626014634,-0.34342973731703 +-157.4432,55.974115,13.719616,-214622.141043541,668195.768225143,111.417213439941,21,2.04695229249364,-0.260301135507653 +-157.38388,55.9758222,13.719616,-210918.132349358,668195.774161349,113.154663085938,21,2.05367245586709,-0.235891584009716 +-157.32456,55.9774997,13.719616,-207214.460559365,668195.790959814,121.463523864746,21,2.08444587659565,-0.1241137363148 +-157.26523,55.9791475,13.719616,-203510.497022121,668195.787209097,113.588188171387,21,2.05533317223153,-0.229859388158423 +-157.20589,55.9807657,13.719616,-199806.235310101,668195.774962967,110.609313964844,21,2.04379169869766,-0.271781314297958 +-157.14655,55.9823543,13.719616,-196102.292325401,668195.784684242,100.277740478516,21,2.00120453959843,-0.42647003173176 +-157.0872,55.9839131,13.719616,-192398.040478697,668195.764405549,94.9004516601562,21,1.97726827937194,-0.513413360963224 +-157.02785,55.9854423,13.719616,-188694.095593804,668195.765770169,101.656791687012,21,2.00713639914384,-0.404923824741523 +-156.9685,55.9869419,13.719616,-184990.45180607,668195.788079531,110.788970947266,121,2.04449652848672,-0.269221171325628 +-156.90914,55.9884118,13.719616,-181286.480974727,668195.792213955,109.249198913574,121,2.03841826112356,-0.291299173298855 +-156.84977,55.989852,13.719616,-177582.177202957,668195.77917361,98.5100173950195,121,1.99348039575825,-0.454526326849407 +-156.7904,55.9912625,13.719616,-173878.15735594,668195.776154326,88.2196197509766,21,1.94556518152663,-0.628568061302418 +-156.73103,55.9926433,13.67039867,-170174.415534638,668195.782510087,76.7747421264648,21,1.88521836639493,-0.847764918556634 +-156.67165,55.9939945,13.12368166,-166470.322627469,668195.783680451,32.2749977111816,21,1.50886622013997,-2.21478333535191 +-156.61227,55.9953159,13.719616,-162766.496403015,668195.78295167,192.024154663086,121,2.28335586191751,0.598384104936382 +-156.55288,55.9966077,13.719616,-159062.307309231,668195.778044897,189.342376708984,121,2.27724782427137,0.576197968798077 +-156.49349,55.9978698,13.719616,-155358.372654363,668195.782296248,195.505187988281,121,2.29115828646226,0.626724737916583 +-156.43409,55.9991022,13.719616,-151654.063771084,668195.772291669,203.529541015625,220,2.3086274532122,0.690177737748981 +-156.37469,56.0003049,13.719616,-147949.997517351,668195.771417561,208.48127746582,220,2.31906705950942,0.728097367580778 +-156.31529,56.0014779,13.719616,-144246.16798706,668195.779122659,210.521301269531,220,2.32329604580482,0.743458252878528 +-156.25588,56.0026211,13.719616,-140541.946888658,668195.762565475,208.440124511719,220,2.31898132392063,0.727785951450926 +-156.19647,56.0037347,13.719616,-136837.950310182,668195.765782244,206.289108276367,220,2.31447629854832,0.711422413436416 +-156.13706,56.0048186,13.719616,-133134.172731399,668195.777121419,200.132034301758,220,2.30131660991048,0.66362266815472 +-156.07764,56.0058727,13.719616,-129429.985828245,668195.765454386,169.867263793945,121,2.23010969126752,0.40497881516542 +-156.01822,56.0068972,13.719616,-125726.005746005,668195.773186987,91.8020401000977,121,1.96285233255604,-0.565776194519451 +-155.9588,56.0078919,13.719616,-122022.227260825,668195.777564278,71.9159469604492,22,1.85682520344275,-0.950896990614513 +-155.89937,56.0088569,13.719616,-118318.021348829,668195.771456486,71.8989486694336,22,1.85672254002959,-0.951269893434162 +-155.83994,56.0097922,13.719616,-114614.004860324,668195.773352502,64.6751327514648,22,1.81073732881756,-1.11830130604227 +-155.78051,56.0106977,13.719616,-110910.172180597,668195.77167939,52.7158584594727,22,1.72194128324662,-1.44083388847065 +-155.72108,56.0115736,13.719616,-107206.516787726,668195.78830936,45.980110168457,22,1.66257000750515,-1.65648730821288 +-155.66164,56.0124197,13.719616,-103502.410591349,668195.784967361,43.012752532959,22,1.63359723543076,-1.76172468603956 +-155.6022,56.013236,13.719616,-99798.4704090439,668195.777965016,27.5071468353271,22,1.43944554575376,-2.46693903935582 +-155.54275,56.0140227,13.719616,-96094.067013599,668195.774747325,26.3655681610107,22,1.42103713453466,-2.53380364318724 +-155.48331,56.0147796,13.719616,-92390.4405422443,668195.782160633,26.7220363616943,22,1.42686955062046,-2.51261864322634 +-155.42386,56.0155068,13.719616,-88686.3392823296,668195.782620835,31.3357429504395,22,1.49603999600268,-2.26137184238741 +-155.36441,56.0162042,13.719616,-84982.3803079319,668195.779118198,32.5850982666016,22,1.51301903503174,-2.19969912633362 +-155.30495,56.0168719,13.719616,-81277.9346883457,668195.770239212,38.5294456481934,22,1.58579276054006,-1.93536418359816 +-155.2455,56.0175099,13.719616,-77574.2420306753,668195.780712467,40.0699501037598,22,1.60281880163721,-1.87352074261735 +-155.18604,56.0181181,13.719616,-73870.0510881105,668195.775179339,50.094913482666,22,1.69979363088607,-1.52128048341352 +-155.12658,56.0186966,13.719616,-70165.9784846015,668195.776745183,58.7594909667969,22,1.76907802484339,-1.26961978882563 +-155.06712,56.0192453,13.719616,-66462.0184786857,668195.773997827,59.9494705200195,22,1.77778535171762,-1.23799229229993 +-155.00766,56.0197643,13.719616,-62758.1649502503,668195.77783166,89.6260299682617,22,1.95243415954852,-0.603617972525383 +-154.9482,56.0202535,13.719616,-59054.4121370185,668195.776861519,121.099449157715,22,2.0831421676822,-0.128849179204024 +-154.88873,56.020713,13.719616,-55350.1311749066,668195.773674924,150.389022827148,122,2.17721613745522,0.212854330395842 +-154.82926,56.0211428,13.719616,-51645.9389048412,668195.777510891,171.745254516602,122,2.23488474593114,0.422323176639993 +-154.7698,56.0215428,13.719616,-47942.4522966152,668195.784243781,197.437271118164,122,2.29542913978774,0.642237696217652 +-154.71033,56.021913,13.719616,-44238.4198711731,668195.778693792,207.204650878906,221,2.31639949927964,0.718408027428743 +-154.65086,56.0222535,13.719616,-40534.4583292697,668195.779614922,305.151153564453,221,2.48451501606135,1.32905156932568 +-154.59138,56.0225642,13.719616,-36829.9390836134,668195.770157375,290.801422119141,221,2.46359652604183,1.25306964284331 +-154.53191,56.0228452,13.719616,-33126.1016175189,668195.772975242,293.896423339844,221,2.46819430082858,1.26977007320436 +-154.47244,56.0230965,13.719616,-29422.3172439382,668195.781835991,288.492370605469,221,2.4601343324042,1.24049396734299 +-154.41296,56.0233179,13.719616,-25717.9574142622,668195.770455861,321.781372070312,221,2.50756089917496,1.41276079474426 +-154.35349,56.0235097,13.719616,-22014.2614925072,668195.780479504,234.132904052734,221,2.36946245190404,0.911147817035106 +-154.29401,56.0236716,13.719616,-18309.9782059696,668195.771187611,132.864501953125,122,2.12340896389866,0.0174113179420454 +-154.23454,56.0238038,13.719616,-14606.3470176402,668195.770873553,100.037132263184,122,2.00016123343705,-0.430259617499093 +-154.17506,56.0239063,13.719616,-10902.1164765458,668195.774520158,167.230529785156,122,2.22331556560821,0.380300611534296 +-154.11558,56.023979,13.719616,-7197.90344039696,668195.773689366,163.858367919922,122,2.21446862483741,0.34816599748645 +-154.05611,56.024022,13.719616,-3494.3247080603,668195.780021971,148.538146972656,122,2.17183800174889,0.193319406437692 +-153.99663,56.0240352,13.719616,209.871172200659,668195.780740085,133.186309814453,134,2.12445958611356,0.0212274777039824 +-153.93715,56.0240186,13.719616,3914.06739217269,668195.776921532,94.2179870605469,134,1.97413382142805,-0.524798606878777 +-153.87768,56.0239723,13.719616,7617.64712309587,668195.778574968,74.9802932739258,134,1.87494713476516,-0.885072963537344 +-153.8182,56.0238962,13.719616,11321.8618466627,668195.776309979,79.9197769165039,134,1.90265426295483,-0.784432765550731 +-153.75872,56.0237904,13.719616,15026.0947140733,668195.780720313,92.2905502319336,134,1.96515723523798,-0.557404130093896 +-153.69925,56.0236548,13.719616,18729.7289375029,668195.777886235,69.0673522949219,134,1.83927280759518,-1.01465230228543 +-153.63977,56.0234894,13.719616,22434.0159978622,668195.772953008,78.9316177368164,134,1.89725100394527,-0.804058944517117 +-153.5803,56.0232943,13.719616,26137.716252996,668195.77094629,82.7206649780273,134,1.9176140169869,-0.730094668967358 +-153.52082,56.0230695,13.719616,29842.0811536118,668195.779269477,247.290390014648,231,2.39320723951252,0.997395663066232 +-153.46135,56.0228149,13.719616,33545.8711881719,668195.77844877,484.672088623047,430,2.68544801021993,2.05889755609605 +-159.80532,55.8484666,9.086191102,-362782.22834056,664491.782607817,13.046516418457,12,1.11549456514518,-3.64362146574166 +-159.51035,55.8626056,11.85847434,-344262.008016074,664491.761895865,21.1620998382568,12,1.32555875896436,-2.88060835550014 +-159.33327,55.8707358,7.051923931,-333150.33700989,664491.790540323,11.9897050857544,12,1.07880850076318,-3.77687572282238 +-159.27422,55.8733869,10.00501259,-329446.053625279,664491.76187426,29.0386047363281,12,1.46297574529696,-2.38147063842728 +-159.21517,55.8760086,13.719616,-325742.29058586,664491.781829028,59.0916290283203,12,1.77152596270362,-1.26072817980626 +-159.15611,55.8786008,11.19280505,-322038.419691439,664491.789616427,57.8691101074219,12,1.76244680397392,-1.29370627576243 +-159.09704,55.8811636,13.01427749,-318334.434311951,664491.796849495,86.2479476928711,12,1.93574876964368,-0.664224071144179 +-159.03796,55.8836968,12.05210473,-314630.330389126,664491.781815384,105.199111938477,12,2.02201207364047,-0.350891129029569 +-158.97887,55.8862006,13.02271735,-310926.100444282,664491.767267405,113.787902832031,20,2.05609609323167,-0.227088241326579 +-158.91978,55.8886749,13.719616,-307222.362871675,664491.788892112,129.327102661133,20,2.11168954810338,-0.0251569452807084 +-158.86068,55.8911197,12.354687,-303518.488567323,664491.799865577,62.5692024230957,20,1.79636061901051,-1.17052161958302 +-158.80157,55.8935349,9.110829274,-299814.472551428,664491.789636043,30.9593887329102,20,1.49079237731626,-2.28043269127598 +-158.74245,55.8959207,13.5801364,-296110.307416914,664491.781015568,133.613784790039,20,2.12585126614416,0.0262824568001614 +-158.68332,55.898277,13.719616,-292405.988190207,664491.763479512,130.515533447266,20,2.11566220277752,-0.0107271295957112 +-158.62419,55.9006037,13.719616,-288702.133177219,664491.769985402,101.97142791748,20,2.00847850082023,-0.400048928378924 +-158.56505,55.9029009,13.719616,-284998.112469575,664491.767681748,107.179077148438,20,2.0301100132873,-0.321477100850166 +-158.5059,55.9051686,13.719616,-281293.920273295,664491.757199808,121.208442687988,20,2.08353287135754,-0.127430031937277 +-158.44675,55.9074067,13.719616,-277590.174859319,664491.769861379,127.747985839844,20,2.10635406148356,-0.0445369555833886 +-158.38759,55.9096153,13.719616,-273886.24634376,664491.774529975,99.6616058349609,20,1.99852788062396,-0.436192421121559 +-158.32842,55.9117944,13.719616,-270182.128927507,664491.771876534,70.824592590332,20,1.85018408497462,-0.975019428454685 +-158.26925,55.9139439,13.719616,-266478.440846704,664491.79158724,73.9769897460938,120,1.86909665513213,-0.906323575457648 +-158.21006,55.9160638,13.719616,-262773.929627464,664491.753548594,178.168365478516,120,2.25083059578544,0.480243054709478 +-158.15088,55.9181542,13.719616,-259070.458702346,664491.788297621,180.86589050293,120,2.25735667098853,0.503947622574409 +-158.09168,55.9202151,13.719616,-255366.152303103,664491.777854721,117.154327392578,20,2.06875833499878,-0.18109536506482 +-158.03248,55.9222463,13.719616,-251662.252617047,664491.778167285,76.2024765014648,20,1.88196908568925,-0.859567233516703 +-157.97327,55.924248,13.719616,-247958.129122036,664491.773225368,90.4628143310547,20,1.95647009467935,-0.588958304159616 +-157.91406,55.9262201,13.719616,-244254.399985163,664491.789444515,91.6077041625977,20,1.96193199915482,-0.569119108121966 +-157.85484,55.9281626,13.719616,-240550.43604397,664491.789705277,101.185897827148,120,2.00511998955304,-0.412247999915912 +-157.79561,55.9300755,13.719616,-236846.231455347,664491.774796193,90.9940795898438,120,1.95901313644081,-0.579721250625614 +-157.73638,55.9319589,13.719616,-233142.403068772,664491.791754255,80.5829391479492,21,1.906243103614,-0.771397071919517 +-157.67714,55.9338126,13.719616,-229438.322980885,664491.782915512,84.6849670410156,21,1.92780632283865,-0.69307330494007 +-157.61789,55.9356367,13.719616,-225733.98470749,664491.76023715,88.5798187255859,21,1.94733478718651,-0.622140348449978 +-157.55864,55.9374313,13.719616,-222030.00512356,664491.769124696,85.0197982788086,21,1.9295200702088,-0.686848485339482 +-157.49939,55.9391962,13.719616,-218326.379582804,664491.786499052,81.0685424804688,21,1.90885236497016,-0.761919489916616 +-157.44013,55.9409315,13.719616,-214622.478305792,664491.790368807,110.225845336914,21,2.04228343817424,-0.277259747019401 +-157.38086,55.9426372,13.719616,-210918.295439563,664491.781616005,116.66056060791,21,2.06692405908471,-0.187757978739168 +-157.32159,55.9443133,13.719616,-207214.448450692,664491.792337931,113.868049621582,21,2.05640188194052,-0.225977529455224 +-157.26231,55.9459597,13.719616,-203510.308710104,664491.779992607,107.803268432617,21,2.03263192820445,-0.312316786044912 +-157.20303,55.9475765,13.719616,-199806.493114575,664491.786721185,88.5415573120117,21,1.94714715629277,-0.622821877411246 +-157.14374,55.9491637,13.719616,-196102.372485141,664491.782257581,90.0597152709961,21,1.95453056958194,-0.596003212909015 +-157.08444,55.9507213,13.719616,-192397.94096247,664491.767550939,90.6609268188477,21,1.95742015450045,-0.585507415715317 +-157.02515,55.9522492,13.719616,-188694.439835342,664491.789254408,108.179946899414,121,2.03414676393081,-0.306814470309608 +-156.96584,55.9537474,13.719616,-184989.993249623,664491.761430117,120.383499145508,121,2.08056696265964,-0.138203058882655 +-156.90654,55.9552161,13.719616,-181286.464299764,664491.790905061,134.522644042969,121,2.12879539478582,0.0369763723646501 +-156.84722,55.956655,13.719616,-177581.978622276,664491.761706726,138.150115966797,121,2.14035125381076,0.0789505507137589 +-156.78791,55.9580644,13.719616,-173878.398851483,664491.78848042,123.81916809082,121,2.09278788177364,-0.09381319246302 +-156.72859,55.959444,13.719616,-170174.473882865,664491.784248696,130.833129882812,121,2.1167177310176,-0.00689314974995827 +-156.66926,55.960794,13.719616,-166470.196893592,664491.772328661,191.128311157227,121,2.28132502231759,0.59100751585015 +-156.60993,55.9621144,13.719616,-162766.185336164,664491.778286018,197.938186645508,121,2.29652958728163,0.646234835614448 +-156.5506,55.963405,13.719616,-159062.434197235,664491.779239663,197.282699584961,121,2.29508900210866,0.641002219082272 +-156.49126,55.9646661,13.719616,-155358.312971647,664491.784622564,199.250457763672,220,2.2993993278298,0.656658552390878 +-156.43192,55.9658974,13.719616,-151654.44036309,664491.784949333,202.183151245117,220,2.30574496121465,0.679707704068748 +-156.37257,55.9670991,13.719616,-147950.186322336,664491.779657575,211.686218261719,220,2.32569258438824,0.75216316505374 +-156.31322,55.968271,13.719616,-144246.169073388,664491.769310599,213.485412597656,220,2.32936820514661,0.76551406877476 +-156.25387,55.9694134,13.719616,-140542.381547591,664491.7867935,207.643859863281,220,2.31731909332251,0.721748255470699 +-156.19451,55.970526,13.719616,-136838.195683758,664491.777556748,203.870651245117,220,2.3093547102328,0.692819342827615 +-156.13515,55.9716089,13.719616,-133134.228508735,664491.773951648,191.126312255859,220,2.28132048025699,0.590991017789588 +-156.07579,55.9726622,13.719616,-129430.47376749,664491.786624178,133.850051879883,121,2.12661854385424,0.0290694284460195 +-156.01642,55.9736857,13.719616,-125726.302938387,664491.773876836,80.5873107910156,121,1.90626666355092,-0.771311495503944 +-155.95705,55.9746796,13.719616,-122022.332747213,664491.777571997,71.6332702636719,22,1.85511477839647,-0.957109742586503 +-155.89767,55.9756438,13.719616,-118317.934312416,664491.768296392,69.7297286987305,22,1.84341797547491,-0.999595869397555 +-155.8383,55.9765783,13.719616,-114614.348365899,664491.781798073,62.3072509765625,22,1.79453859041306,-1.17713974750769 +-155.77892,55.9774831,13.719616,-110910.322355383,664491.782574579,49.0465965270996,22,1.69060887592017,-1.55464213503971 +-155.71954,55.9783582,13.719616,-107206.473690462,664491.788027356,46.1553001403809,22,1.66422157945843,-1.65048832747302 +-155.66015,55.9792035,13.719616,-103502.17341696,664491.771026316,32.0584678649902,22,1.50594276275673,-2.22540216700564 +-155.60076,55.9800192,13.719616,-99798.0383758767,664491.77017238,28.0497608184814,22,1.44792916236022,-2.43612412237589 +-155.54137,55.9808052,13.719616,-96094.0629425489,664491.773947965,32.7985458374023,22,1.51585458917535,-2.18939958433631 +-155.48198,55.9815615,13.719616,-92390.2412030987,664491.781992826,33.5376358032227,22,1.5255324442628,-2.15424685232382 +-155.42258,55.982288,13.719616,-88685.9441609589,664491.769461235,30.5257949829102,22,1.48466698309015,-2.30268187146678 +-155.36319,55.9829849,13.719616,-84982.4120552816,664491.785575853,34.4902801513672,22,1.53769672198985,-2.11006272358863 +-155.30379,55.983652,13.719616,-81278.3927963219,664491.781576558,43.0910224914551,22,1.63438679942901,-1.7588567642339 +-155.24439,55.9842894,13.719616,-77574.5035500384,664491.781656637,43.866771697998,22,1.64213567440188,-1.7307106385833 +-155.18498,55.9848971,13.719616,-73870.1150789266,664491.774400672,52.5435523986816,22,1.7205194315066,-1.44599845982729 +-155.12558,55.9854751,13.719616,-70166.4681075973,664491.782334166,55.8172225952148,22,1.7467682226653,-1.35065535818797 +-155.06617,55.9860233,13.719616,-66462.3102557006,664491.772357321,75.8544921875,22,1.8799813052872,-0.866787419305975 +-155.00676,55.9865419,13.719616,-62758.2585582064,664491.77763406,113.479187011719,22,2.05491621575979,-0.231373893074984 +-154.94735,55.9870307,13.719616,-59054.307444626,664491.775634146,144.30729675293,122,2.1592882913112,0.147735276084 +-154.88794,55.9874898,13.719616,-55350.4508171854,664491.7772796,171.032455444336,122,2.23307853076017,0.415762487593874 +-154.82852,55.9879192,13.719616,-51646.0594358438,664491.774583103,225.763641357422,122,2.35365400123257,0.853727012015273 +-154.76911,55.9883188,13.719616,-47942.3741518918,664491.772312148,246.443786621094,221,2.39171787312905,0.991985859253983 +-154.70969,55.9886888,13.719616,-44238.142135587,664491.777581255,358.964599609375,320,2.55505162141295,1.58526065311429 +-154.65027,55.989029,13.719616,-40533.9810358701,664491.775703707,425.810821533203,320,2.62921669437904,1.8546493669465 +-154.59086,55.9893395,13.719616,-36830.5081240792,664491.783216115,433.59423828125,320,2.6370835025449,1.88322385961547 +-154.53144,55.9896202,13.719616,-33126.4709270262,664491.777179459,478.357360839844,320,2.67975246116167,2.0382096962449 +-154.47202,55.9898712,13.719616,-29422.4867355128,664491.774715624,609.817749023438,221,2.78520006055209,2.42122547497225 +-154.41259,55.9900925,13.719616,-25717.9263075724,664491.771836895,526.128601074219,221,2.72109191128411,2.1883663785434 +-154.35317,55.9902841,13.719616,-22014.0303636327,664491.776744661,315.738922119141,320,2.49932812202412,1.38285699826384 +-154.29375,55.9904459,13.719616,-18310.1697106871,664491.773773202,122.614059448242,221,2.08854027108542,-0.109241726871443 +-154.23433,55.990578,13.719616,-14606.3383578931,664491.773995728,112.918327331543,122,2.0527644362827,-0.239189770314798 +-154.1749,55.9906804,13.719616,-10901.9070626856,664491.775710004,119.251434326172,122,2.07646361132805,-0.153107602132084 +-154.11548,55.990753,13.719616,-7198.1165643741,664491.771562411,216.821899414062,122,2.33610314463002,0.789977291321609 +-154.05606,55.9907959,13.719616,-3494.33758090641,664491.770467874,218.613357543945,221,2.33967669434926,0.802957443894512 +-153.99663,55.9908091,13.719616,210.059130486796,664491.772438296,212.940933227539,134,2.32825915305932,0.761485675038733 +-153.93721,55.9907926,13.719616,3913.8328500136,664491.777962168,176.208160400391,134,2.24602601721334,0.462791453972368 +-153.87779,55.9907463,13.719616,7617.61284097332,664491.775373318,125.08171081543,134,2.09719381271016,-0.077809593723681 +-153.81836,55.9906703,13.719616,11322.0283455666,664491.77754542,84.7467498779297,134,1.92812305156955,-0.691922855786045 +-153.75894,55.9905645,13.719616,15025.8386843891,664491.770513876,103.131546020508,134,2.0133915282039,-0.382203410603826 +-153.69952,55.9904291,13.719616,18729.6730291342,664491.777769465,87.6626052856445,134,1.94281437350897,-0.638559781181316 +-153.6401,55.9902639,13.719616,22433.5373923969,664491.777079219,93.7823944091797,134,1.97212131675236,-0.532108598286908 +-153.58067,55.9900689,13.719616,26138.0610465339,664491.772454802,100.994735717773,134,2.00429873706674,-0.415231023354941 +-153.52125,55.9898443,13.719616,29842.0031404567,664491.778966753,274.9736328125,134,2.43929105138284,1.16478522140871 +-153.46183,55.9895899,13.719616,33545.9930670532,664491.77780139,414.414001464844,231,2.61743442013533,1.81185278389746 +-159.80016,55.8153598,13.719616,-362782.447253514,660787.802138508,104.087265014648,112,2.01739759721283,-0.367652224517462 +-159.74123,55.818244,13.719616,-359078.033808694,660787.764947833,107.791572570801,112,2.03258480789091,-0.312487940473169 +-159.6823,55.8210988,12.93986835,-355374.18588779,660787.775895848,66.7161178588867,12,1.82423076722327,-1.06928928634197 +-159.38751,55.8349318,9.18271588,-336854.494405259,660787.798054681,37.3527603149414,12,1.57232270107115,-1.98429128432699 +-159.32852,55.8376102,13.36322569,-333150.176065064,660787.778108425,40.9336280822754,12,1.61208023930157,-1.83988055754291 +-159.26953,55.8402591,13.719616,-329446.38401575,660787.793155944,69.7460632324219,12,1.84351969919027,-0.999226379828525 +-159.21053,55.8428785,13.51356343,-325742.488610011,660787.792950543,73.1240615844727,12,1.86406030573912,-0.924617033970291 +-159.0925,55.8480292,7.526532187,-318334.361229174,660787.793201514,38.5395431518555,12,1.58590656221865,-1.93495082341927 +-159.03347,55.8505603,13.67288297,-314630.119473665,660787.772454262,74.8909301757812,12,1.87442922473392,-0.886954160597046 +-158.97444,55.8530619,13.719616,-310926.375185284,660787.785310256,123.187477111816,120,2.09056656093179,-0.101881663788725 +-158.9154,55.8555341,13.49043819,-307222.49788279,660787.795492124,116.545883178711,20,2.06649693727876,-0.189309407051072 +-158.79729,55.8603901,4.027848913,-299814.322839713,660787.787840127,16.5524482727051,20,1.21886223936176,-3.26816056891545 +-158.73822,55.8627738,8.886644181,-296110.014347227,660787.760038621,51.683349609375,20,1.71335065262106,-1.47203751091277 +-158.67915,55.8651281,13.719616,-292406.173646134,660787.775893841,105.482704162598,20,2.02318125487036,-0.346644329085047 +-158.62007,55.8674528,13.719616,-288702.172649395,660787.768631947,109.341636657715,20,2.03878557025148,-0.289965001705774 +-158.56098,55.8697481,13.719616,-284998.004008171,660787.761110192,123.2646484375,20,2.09083854139798,-0.100893753104547 +-158.50189,55.8720139,13.719616,-281294.286594559,660787.785200222,107.041534423828,120,2.02955232601255,-0.323502780211874 +-158.44279,55.8742501,13.719616,-277590.391482157,660787.786955486,113.463882446289,120,2.05485763993864,-0.231586657176611 +-158.38368,55.8764568,13.719616,-273886.31211148,660787.77815533,126.426475524902,120,2.10183803099023,-0.0609404673385899 +-158.32456,55.8786341,13.719616,-270182.041960944,660787.770595063,119.07886505127,120,2.07583468670428,-0.155392035878556 +-158.26544,55.8807817,13.719616,-266478.201287081,660787.771719132,78.1302719116211,120,1.89281933575859,-0.82015602829519 +-158.20631,55.8828999,13.719616,-262774.158235805,660787.774353034,102.265953063965,120,2.00973107009968,-0.395499239237088 +-158.14717,55.8849885,13.719616,-259069.908426788,660787.756962511,119.944206237793,120,2.07897927473214,-0.143969994606578 +-158.08803,55.8870476,13.719616,-255366.06922042,660787.769848759,88.6185607910156,120,1.94752469259702,-0.621450557794611 +-158.02888,55.8890771,13.719616,-251662.01160948,660787.763057314,79.4544219970703,20,1.90011807266341,-0.793644932589955 +-157.96973,55.8910771,13.719616,-247958.352971032,660787.785801733,94.8026123046875,20,1.97682030457309,-0.51504053329739 +-157.91057,55.8930475,13.719616,-244254.464274952,660787.789268292,97.7197265625,20,1.98998224306845,-0.467232615890952 +-157.8514,55.8949884,13.719616,-240550.339036467,660787.785361457,87.123893737793,120,1.94013727665416,-0.64828376107751 +-157.79222,55.8968997,13.719616,-236845.972081228,660787.763745226,85.6730194091797,120,1.9328440731882,-0.674774757753398 +-157.73304,55.8987814,13.719616,-233141.98144615,660787.760329085,89.0884399414062,21,1.94982135392049,-0.613108428335367 +-157.67386,55.9006336,13.719616,-229438.360671786,660787.785386048,96.738639831543,21,1.98559997681088,-0.483150257761774 +-157.61467,55.9024562,13.719616,-225734.480671106,660787.792954555,94.6828384399414,21,1.97627126890561,-0.517034787552045 +-157.55547,55.9042492,13.719616,-222030.335598142,660787.783878159,93.3436660766602,21,1.9700848538193,-0.539505612924173 +-157.49626,55.9060126,13.719616,-218325.919605532,660787.759013816,89.8393630981445,21,1.95346666440276,-0.599867620188562 +-157.43706,55.9077465,13.719616,-214622.474025142,660787.794997793,89.5955200195312,21,1.95228629448982,-0.604155060623478 +-157.37784,55.9094507,13.719616,-210918.122534283,660787.77182629,90.6518325805664,21,1.95737658804083,-0.585665661531781 +-157.31862,55.9111253,13.719616,-207214.10645224,660787.765604059,95.7448272705078,21,1.98111531999253,-0.499439811374513 +-157.2594,55.9127704,13.719616,-203510.419379502,660787.786701396,84.7925033569336,21,1.92835745727281,-0.691071427365785 +-157.20017,55.9143858,13.719616,-199806.432687149,660787.782016872,85.4905700683594,21,1.93191821305408,-0.678137746027322 +-157.14093,55.9159717,13.719616,-196102.139436238,660787.774754355,104.170303344727,21,2.01774392883222,-0.366394249222935 +-157.08169,55.9175279,13.719616,-192398.15871286,660787.772567492,108.986488342285,121,2.03737265938908,-0.29509709724294 +-157.02245,55.9190545,13.719616,-188694.484122481,660787.785880665,117.745269775391,121,2.07094346907728,-0.173158334392318 +-156.9632,55.9205515,13.719616,-184990.48592771,660787.786142685,129.701019287109,121,2.11294338910665,-0.0206026368749717 +-156.90394,55.9220189,13.719616,-181286.158268586,660787.774344337,147.164596557617,121,2.1678033441797,0.178664378540452 +-156.84468,55.9234566,13.719616,-177582.119639936,660787.767093242,153.866653442383,121,2.18714450810197,0.248917006423937 +-156.78542,55.9248648,13.719616,-173878.363214982,660787.786006277,151.75520324707,121,2.18114359070446,0.22711996160384 +-156.72615,55.9262433,13.719616,-170174.260196523,660787.782543569,160.782638549805,121,2.20623915144546,0.318274201201295 +-156.66688,55.9275921,13.719616,-166470.428568977,660787.782814982,194.843933105469,121,2.28968688762505,0.621380197360818 +-156.6076,55.9289113,13.719616,-162766.238120944,660787.772833285,206.128067016602,121,2.3141371306464,0.710190458808491 +-156.54832,55.9302009,13.719616,-159062.306864584,660787.777621068,209.080139160156,220,2.32031278048477,0.732622181727421 +-156.48903,55.9314609,13.719616,-155358.005053861,660787.773196566,212.25651550293,220,2.32686103038143,0.756407294408674 +-156.42974,55.9326911,13.719616,-151653.951514411,660787.761215096,213.241317749023,220,2.32887135763346,0.763709376792587 +-156.37045,55.9338918,13.719616,-147950.139123838,660787.774532147,227.288299560547,220,2.35657707951256,0.86434446665782 +-156.31115,55.9350628,13.719616,-144245.938938742,660787.76860053,224.404968261719,220,2.35103246784599,0.84420485449511 +-156.25185,55.9362041,13.719616,-140541.968936667,660787.765720357,219.324417114258,220,2.34108698383296,0.808080017836011 +-156.19255,55.9373158,13.719616,-136838.222847714,660787.776510436,207.261123657227,220,2.31651784833359,0.718837904972846 +-156.13324,55.9383978,13.719616,-133134.0712783,660787.76927515,173.777755737305,220,2.23999418420234,0.440882114819851 +-156.07393,55.9394502,13.719616,-129430.131855312,660787.775823465,130.689514160156,121,2.11624074347137,-0.00862570466369659 +-156.01462,55.9404729,13.719616,-125726.399042205,660787.784533113,79.7303771972656,121,1.90162381870647,-0.788175633178844 +-155.9553,55.9414659,13.719616,-122022.243055086,660787.77656237,73.4268569946289,22,1.86585493881516,-0.918098414398848 +-155.89598,55.9424293,13.719616,-118318.281548294,660787.782088536,68.1346206665039,22,1.83336784236548,-1.03610082144459 +-155.83666,55.943363,13.719616,-114614.508953099,660787.789528964,59.719181060791,22,1.77611384354029,-1.2440636870959 +-155.77733,55.944267,13.719616,-110910.295483349,660787.78175574,49.5763244628906,22,1.69527432548433,-1.53769589057083 +-155.718,55.9451413,13.719616,-107206.259109371,660787.776171194,40.4495849609375,22,1.60691406982717,-1.85864555964549 +-155.65867,55.945986,13.719616,-103502.393643839,660787.783518668,30.2333278656006,22,1.48048595379777,-2.31786856324125 +-155.59933,55.946801,13.719616,-99798.0695968226,660787.777241152,24.8390979766846,22,1.39513582053589,-2.62788460860183 +-155.53999,55.9475863,13.719616,-96093.9049366581,660787.773108406,24.9618186950684,22,1.39727622445822,-2.62011005062382 +-155.48066,55.9483419,13.719616,-92390.5176310759,660787.784672761,29.9222679138184,22,1.47599450714462,-2.33418277947202 +-155.42131,55.9490678,13.719616,-88686.0301328009,660787.769852649,36.0701866149902,22,1.55714838921747,-2.03940871615934 +-155.36197,55.9497641,13.719616,-84982.3079369964,660787.781196069,40.543758392334,22,1.60792400517087,-1.85497718621293 +-155.30262,55.9504306,13.719616,-81278.0978410078,660787.769944442,50.2137069702148,22,1.70082228385756,-1.51754412221425 +-155.24327,55.9510675,13.719616,-77574.0173630957,660787.771436354,51.2405891418457,22,1.70961411442905,-1.48560968414035 +-155.18392,55.9516747,13.719616,-73870.0608182249,660787.774235387,54.2162437438965,22,1.73412942512554,-1.39656307832437 +-155.12457,55.9522522,13.719616,-70166.2222922898,660787.778063501,63.5401229858398,22,1.80304805109579,-1.14623095746613 +-155.06522,55.9528,13.719616,-66462.4958707274,660787.782656207,93.4302444458008,22,1.97048748511356,-0.538043141141037 +-155.00586,55.9533181,13.719616,-62758.2517599416,660787.778312624,128.039154052734,22,2.10734279612312,-0.0409455891595607 +-154.9465,55.9538065,13.719616,-59054.1079231165,660787.775360918,156.613784790039,122,2.19482998501933,0.276832852241314 +-154.88714,55.9542652,13.719616,-55350.0584444589,660787.773577372,217.941513061523,122,2.3383399616661,0.798102049247787 +-154.82778,55.9546942,13.719616,-51646.0974077984,660787.772751867,295.282196044922,221,2.47023726209361,1.27719069163813 +-154.76842,55.9550935,13.719616,-47942.2188966287,660787.772687895,363.513244628906,221,2.56052023903126,1.60512423320285 +-154.70906,55.9554631,13.719616,-44238.4169941171,660787.773202529,567.517822265625,320,2.7539795046142,2.30782350457198 +-154.64969,55.9558031,13.719616,-40534.0617954894,660787.779169543,623.424194335938,320,2.79478365270934,2.45603581711693 +-154.59033,55.9561133,13.719616,-36830.3953686064,660787.780904878,597.628051757812,320,2.7764309744126,2.38937365116725 +-154.35286,55.9570571,13.719616,-22014.3874102372,660787.777799147,607.038024902344,320,2.78321589616263,2.41401842357282 +-154.29349,55.9572188,13.719616,-18310.3322063909,660787.777858803,204.314559936523,122,2.31029931658241,0.696250422706892 +-154.23412,55.9573508,13.719616,-14606.3062677901,660787.778638898,140.386734008789,122,2.14732607062154,0.104285076181444 +-154.17475,55.9574531,13.719616,-10902.3036757539,660787.780078954,177.559600830078,122,2.24934416002145,0.474843895743643 +-154.11538,55.9575256,13.719616,-7198.31853088231,660787.770984938,234.258193969727,221,2.36969479073847,0.911991737997856 +-154.05601,55.9575685,13.719616,-3494.34486563739,660787.773617884,319.764343261719,221,2.50483003418183,1.40284151362274 +-153.99664,55.9575817,13.719616,209.623209529619,660787.776811022,346.633911132812,231,2.53987104740687,1.530120475357 +-153.93727,55.9575652,13.719616,3913.59161352588,660787.780558297,319.909393310547,231,2.50502699220366,1.40355692137544 +-153.8779,55.9575189,13.719616,7617.56628574713,660787.773720122,287.886444091797,134,2.45922121543475,1.2371772658804 +-153.81853,55.957443,13.719616,11321.5531140479,660787.77861201,154.42692565918,134,2.1887230255703,0.254650632422671 +-153.75916,55.9573373,13.719616,15025.5580682137,660787.772974478,130.847122192383,134,2.1167641753541,-0.00672445066326077 +-153.69979,55.957202,13.719616,18729.5869961205,660787.779150151,110.380073547363,134,2.04289067910416,-0.275054074638124 +-153.64042,55.9570369,13.719616,22433.6459072513,660787.774906905,129.873779296875,134,2.11352147858546,-0.0185028508847671 +-153.58105,55.9568421,13.719616,26137.7406797324,660787.771467463,196.143447875977,134,2.29257380520665,0.631866306025473 +-153.52168,55.9566177,13.719616,29841.8771516915,660787.780067957,374.767944335938,231,2.57376243655568,1.65322367431104 +-153.46231,55.9563635,13.719616,33546.0613919819,660787.778517417,467.581390380859,330,2.66985721802502,2.002267348789 +-160.0304,55.7704306,9.488370914,-377598.474488838,657083.796495921,21.5099334716797,12,1.33263906715515,-2.85489065523005 +-159.91272,55.7763996,12.47874625,-370190.37143699,657083.785088323,57.4258842468262,12,1.75910769120813,-1.30583488640546 +-159.85386,55.7793401,11.5901955,-366485.945734292,657083.748247358,53.9676322937012,12,1.73213336480717,-1.40381333913303 +-159.795,55.7822513,13.719616,-362782.095244855,657083.768394985,119.551528930664,112,2.07755513462916,-0.149142877950658 +-159.73613,55.7851331,13.719616,-359078.190805647,657083.779052786,114.099990844727,12,2.05728560957084,-0.22276757846092 +-159.67725,55.7879855,13.71000519,-355374.226696888,657083.78059788,61.2140846252441,12,1.78685135958444,-1.20506196403135 +-159.38271,55.8018068,10.66444765,-336853.932497716,657083.749785037,63.805980682373,12,1.80486138805689,-1.13964440004549 +-159.26484,55.8071296,13.71567653,-329446.195176728,657083.775024245,60.4207229614258,12,1.78118591749932,-1.22564046676269 +-159.20589,55.8097469,13.719616,-325742.171158948,657083.777288221,81.9368209838867,12,1.91347911002061,-0.745113831288874 +-159.14693,55.8123347,13.20175687,-322038.03678206,657083.762190844,70.2377319335938,12,1.8465704791989,-0.988145076057886 +-159.08797,55.8148931,13.26512498,-318334.409859483,657083.789282815,67.5650939941406,12,1.82972238527652,-1.04934216210873 +-159.02899,55.8174221,13.719616,-314630.035776291,657083.762658373,109.76798248291,12,2.04047568201996,-0.283826033356745 +-158.97001,55.8199216,13.719616,-310926.158494297,657083.767046479,130.055114746094,120,2.11412743659591,-0.0163018384332052 +-158.91102,55.8223917,10.76290079,-307222.146978081,657083.766171535,44.6301765441895,20,1.64962860478845,-1.70349417672404 +-158.85202,55.8248324,9.32035753,-303517.995479718,657083.76059251,34.903678894043,20,1.54287120458607,-2.09126752585481 +-158.79302,55.8272436,13.57642906,-299814.323489453,657083.784910339,65.2637023925781,20,1.81467170756183,-1.10401051945959 +-158.73401,55.8296253,9.305702902,-296110.500789723,657083.793447196,30.8388538360596,20,1.48909822859018,-2.28658632300728 +-158.67499,55.8319776,13.61774807,-292406.520813565,657083.797916759,71.2173080444336,20,1.85258555367489,-0.966296608687887 +-158.61596,55.8343004,13.719616,-288702.378579827,657083.787811847,105.787521362305,20,2.02443444158277,-0.342092397250486 +-158.55692,55.8365937,13.719616,-284998.068301912,657083.763754685,127.759346008301,120,2.10639268001119,-0.0443966820682033 +-158.49788,55.8388576,13.719616,-281294.207873529,657083.779857069,109.778419494629,120,2.04051697385221,-0.283676049636163 +-158.43883,55.8410919,13.719616,-277590.16858671,657083.771056422,104.082786560059,120,2.01737891087345,-0.367720098635699 +-158.37977,55.8432968,13.719616,-273885.943151001,657083.760254934,111.00170135498,120,2.04532963539402,-0.26619508924593 +-158.32071,55.8454722,13.719616,-270182.150963562,657083.777690837,129.981948852539,120,2.11388304416789,-0.0171895414882845 +-158.26164,55.847618,13.719616,-266478.162507664,657083.771130759,95.1877670288086,120,1.97858113900159,-0.508644680060869 +-158.20256,55.8497344,13.719616,-262773.970547198,657083.763520535,82.6525344848633,120,1.91725617546239,-0.731394451522521 +-158.14348,55.8518212,13.719616,-259070.195139685,657083.772338754,80.5116577148438,120,1.90585876874886,-0.772793085849806 +-158.08439,55.8538786,13.719616,-255366.204649039,657083.78043475,81.5203857421875,120,1.91126622601931,-0.753151657601555 +-158.02529,55.8559064,13.719616,-251661.994653695,657083.766300837,81.7724304199219,20,1.91260690593695,-0.748281925472545 +-157.96619,55.8579047,13.719616,-247958.183091955,657083.779151927,100.285095214844,20,2.00123639117645,-0.426354337709042 +-157.90708,55.8598734,13.719616,-244254.140378195,657083.770176521,100.634979248047,20,2.00274896137563,-0.420860251015075 +-157.84797,55.8618126,13.719616,-240550.48446747,657083.787501875,95.939697265625,120,1.98199834373092,-0.496232417116615 +-157.78884,55.8637223,13.719616,-236845.960679479,657083.758921215,94.5750427246094,120,1.97577654615889,-0.518831761776057 +-157.72972,55.8656025,13.719616,-233142.436514152,657083.792232678,109.068969726562,120,2.03770121077758,-0.293903704821987 +-157.67058,55.8674531,13.719616,-229438.033467676,657083.770136732,114.497413635254,21,2.05879567657439,-0.21728258408801 +-157.61144,55.8692741,13.719616,-225733.994571058,657083.763119403,111.75333404541,21,2.048260488725,-0.255549393398981 +-157.5523,55.8710656,13.719616,-222030.31338532,657083.781482671,105.437423706055,21,2.02299478568019,-0.34732163840734 +-157.49315,55.8728275,13.719616,-218326.360245398,657083.780408019,98.4801330566406,21,1.99334862669952,-0.455004949681378 +-157.43399,55.8745599,13.719616,-214622.128729401,657083.771898406,90.4288864135742,21,1.95630718275519,-0.589550046767881 +-157.37483,55.8762627,13.719616,-210918.23802243,657083.777468519,93.3388519287109,21,1.97006245474399,-0.53958697275903 +-157.31566,55.8779359,13.719616,-207214.057839693,657083.765141928,88.4359359741211,21,1.94662877659587,-0.624704780430654 +-157.25649,55.8795796,13.719616,-203510.206221448,657083.777607195,89.9386978149414,21,1.95394659530798,-0.598124374154875 +-157.19731,55.8811937,13.719616,-199806.053446501,657083.772898449,93.2407608032227,21,1.9696058085132,-0.541245642209068 +-157.13813,55.8827782,13.719616,-196102.218098936,657083.78148283,101.51148223877,21,2.00651516925316,-0.407180309021145 +-157.07894,55.8843331,13.719616,-192398.069888926,657083.77366831,114.921783447266,121,2.06040235709798,-0.21144666183404 +-157.01975,55.8858584,13.719616,-188694.227398122,657083.778833291,118.016822814941,121,2.07194391861926,-0.169524416099121 +-156.96055,55.8873541,13.719616,-184990.06033432,657083.76842801,126.180511474609,121,2.10099228349278,-0.0640124636497271 +-156.90135,55.8888202,13.719616,-181286.187276828,657083.770742169,142.615631103516,121,2.1541671281103,0.129133749612835 +-156.84214,55.8902568,13.719616,-177581.977454281,657083.769504265,164.320785522461,220,2.21569250236843,0.352611470008541 +-156.78293,55.8916637,13.719616,-173878.050407415,657083.769643777,166.739166259766,220,2.22203762557838,0.375658768585542 +-156.72372,55.893041,13.719616,-170174.399789073,657083.781655401,179.478881835938,220,2.25401335518912,0.491803745313636 +-156.6645,55.8943887,13.719616,-166470.395301489,657083.779845054,201.821502685547,220,2.30496743543997,0.67688350852715 +-156.60527,55.8957068,13.719616,-162766.03108219,657083.765271916,216.027160644531,220,2.33450835752356,0.784184569353389 +-156.54604,55.8969953,13.719616,-159061.925704023,657083.762959771,229.969268798828,220,2.36166980435323,0.882842696887525 +-156.48681,55.8982542,13.719616,-155358.073302496,657083.772321419,235.086273193359,220,2.37122727119035,0.917558144412563 +-156.42758,55.8994834,13.719616,-151654.468419491,657083.781644264,230.790161132812,220,2.36321729037274,0.888463607806868 +-156.36834,55.9006831,13.719616,-147950.479927607,657083.790367427,233.88720703125,220,2.36900646777889,0.909491552541726 +-156.30909,55.9018531,13.719616,-144246.102764261,657083.777339127,236.702102661133,220,2.3742021158508,0.928363629324526 +-156.24984,55.9029934,13.719616,-140541.955467708,657083.764860584,222.788467407227,220,2.34789270593152,0.832800343044466 +-156.19059,55.9041042,13.719616,-136838.031403782,657083.774691481,202.147186279297,220,2.30566770069379,0.679427071804628 +-156.13134,55.9051853,13.719616,-133134.325447607,657083.784045021,167.785430908203,121,2.22475424760788,0.385526315197803 +-156.07208,55.9062367,13.719616,-129430.207262171,657083.77293794,146.266159057617,121,2.16514385698936,0.169004361971915 +-156.01282,55.9072586,13.719616,-125726.294706749,657083.783777153,84.9268264770508,121,1.92904489578787,-0.688574454464598 +-155.95355,55.9082507,13.719616,-122021.958485873,657083.764298847,77.9705810546875,121,1.89193077069501,-0.823383550227804 +-155.89429,55.9092133,13.719616,-118318.440585629,657083.784779745,69.401969909668,22,1.84137179767037,-1.00702817122092 +-155.83502,55.9101462,13.719616,-114614.486905075,657083.786307378,58.3261871337891,22,1.76586358690697,-1.28129554490264 +-155.77574,55.9110494,13.719616,-110910.091539661,657083.770128484,50.8143501281738,22,1.70598637569739,-1.49878666667346 +-155.71647,55.911923,13.719616,-107206.497168729,657083.780931828,36.306640625,22,1.55998606644194,-2.02910146252635 +-155.65719,55.912767,13.7182884,-103502.449043492,657083.785475404,21.3090057373047,22,1.32856318632257,-2.8696954177862 +-155.53862,55.9143659,12.21207731,-96094.2176697065,657083.776457775,18.0557022094727,22,1.25661438336206,-3.13103400637168 +-155.47933,55.9151209,13.719616,-92390.0223577634,657083.774424709,19.6377372741699,22,1.29309144546955,-2.99853890520718 +-155.42004,55.9158462,13.719616,-88685.9744155598,657083.771343576,37.097484588623,22,1.56934446308361,-1.99510909477147 +-155.36075,55.9165419,13.719616,-84982.0677056828,657083.778026898,47.6377601623535,22,1.67795133358324,-1.60061794162974 +-155.30146,55.9172079,13.719616,-81278.2965668265,657083.783012698,56.866340637207,22,1.75485528219623,-1.32128084969505 +-155.24216,55.9178442,13.719616,-77574.0306525437,657083.77431543,55.8503341674805,22,1.74702577595939,-1.34971985111081 +-155.18287,55.9184509,13.719616,-73870.5127263748,657083.786708442,50.1480751037598,22,1.7002542676085,-1.51960731935884 +-155.12357,55.9190279,13.719616,-70166.4882229797,657083.785965661,82.9348297119141,22,1.91873695726895,-0.726015829343889 +-155.06426,55.9195752,13.719616,-66461.9512308109,657083.773496335,113.679000854492,22,2.05568024784264,-0.228598710473615 +-155.00496,55.9200928,13.719616,-62758.1447105645,657083.769623224,142.028671264648,122,2.15237602406703,0.122627948495694 +-154.94566,55.9205808,13.719616,-59054.4381547879,657083.7746896,177.546752929688,122,2.24931273409968,0.474729747825934 +-154.88635,55.9210392,13.719616,-55350.2012442251,657083.780138146,295.571929931641,221,2.47066318731872,1.2787377736269 +-154.82704,55.9214678,13.719616,-51646.0528095463,657083.772917953,412.203887939453,221,2.61511208376218,1.80341739532938 +-154.76773,55.9218668,13.719616,-47941.9866496876,657083.775124337,683.503723144531,320,2.83474088457571,2.601171888185 +-154.35254,55.9238287,13.719616,-22014.0854281074,657083.777913276,627.575866699219,320,2.79766623453109,2.46650617706428 +-154.29323,55.9239902,13.719616,-18310.4657383393,657083.773197786,557.209167480469,320,2.74601825303805,2.27890596647997 +-154.23391,55.9241221,13.719616,-14606.2507834349,657083.774556373,249.427505493164,221,2.39694434338967,1.01096989102368 +-154.17459,55.9242243,13.719616,-10902.0591432465,657083.774097008,262.265930175781,320,2.41874187695071,1.09014475455286 +-154.11528,55.9242968,13.719616,-7198.50933836981,657083.772856799,408.187744140625,320,2.6108599608602,1.78797247127267 +-154.05596,55.9243397,13.719616,-3494.34657092062,657083.77922373,465.997619628906,320,2.66838369826796,1.99691510444695 +-153.99664,55.9243528,13.719616,209.810609872786,657083.772526468,478.704254150391,330,2.68006728698859,2.03935323350852 +-153.93732,55.9243363,13.719616,3913.96812872228,657083.775052377,521.788879394531,330,2.71749481897835,2.17530071257653 +-153.87801,55.9242901,13.719616,7617.50745577371,657083.774515245,440.222747802734,231,2.64367248026629,1.90715690738105 +-153.81869,55.9242142,13.719616,11321.6833795528,657083.772672595,244.843841552734,134,2.38888918487741,0.981711256136028 +-153.75937,55.9241087,13.719616,15025.8773391447,657083.780116482,200.961944580078,134,2.30311382446709,0.670150664400425 +-153.70005,55.9239734,13.719616,18730.0953210987,657083.774601939,212.496658325195,134,2.32735210482238,0.758191016944824 +-153.64074,55.9238085,13.719616,22433.7187139924,657083.775106025,302.957885742188,134,2.48138226130439,1.3176725098712 +-153.58142,55.9236139,13.719616,26138.0023464124,657083.776755895,461.616516113281,231,2.66428133898767,1.98201416461101 +-153.52211,55.9233896,13.719616,29841.7032610745,657083.772326834,599.821411132812,330,2.77802196420921,2.39515258022225 +-153.46279,55.9231357,13.57730054,33546.07615571,657083.781497073,665.01416015625,430,2.82283089284032,2.55791139875199 +-160.14258,55.7312492,2.410448096,-385006.149916253,653379.770849751,32.586254119873,12,1.51303443998129,-2.19964317115985 +-159.96626,55.7403271,13.719616,-373894.148932885,653379.772690974,78.2853775024414,12,1.89368065014161,-0.81702748861246 +-159.90747,55.7432944,13.719616,-370190.286799538,653379.780614114,110.42179107666,112,2.04305478725623,-0.274457986988697 +-159.84867,55.7462324,13.719616,-366486.379788083,653379.786790899,117.633010864258,112,2.07052921310419,-0.174663030327026 +-159.78986,55.7491411,13.719616,-362782.422215264,653379.791578008,124.314384460449,112,2.09452138391403,-0.087516617898346 +-159.73104,55.7520205,13.719616,-359078.408395656,653379.795344937,108.189476013184,12,2.03418501740928,-0.306675522757184 +-159.4368,55.765977,13.719616,-340557.930563574,653379.752918694,89.5999984741211,12,1.95230800226613,-0.604076211783878 +-159.37793,55.7686802,9.728220757,-336854.088251681,653379.7647687,45.8757057189941,12,1.66158275818674,-1.66007327952637 +-159.26016,55.7739985,12.44136946,-329446.111141276,653379.769135314,72.8002471923828,12,1.86213285395734,-0.931618088991216 +-159.20126,55.7766135,13.719616,-325741.965769128,653379.751496423,101.465042114258,12,2.00631643996434,-0.407902150521139 +-159.14236,55.7791992,13.719616,-322038.33203703,653379.784605322,101.046508789062,12,2.00452131300384,-0.414422564021908 +-159.08344,55.7817555,13.719616,-318333.955101058,653379.76032047,92.2917785644531,12,1.96516301540165,-0.557383134889637 +-159.02452,55.7842823,13.719616,-314630.080052255,653379.764476723,113.156631469727,120,2.05368001057813,-0.235864143142885 +-158.96559,55.7867798,13.719616,-310926.074460537,653379.771342236,125.492820739746,120,2.09861888117725,-0.072633338296198 +-158.90665,55.7892478,13.35866579,-307221.934257508,653379.759238822,58.077751159668,20,1.76400979161326,-1.28802905853526 +-158.84771,55.7916864,13.71395563,-303518.277849708,653379.785543326,62.4659042358398,20,1.79564303106067,-1.17312810383681 +-158.78876,55.7940955,13.719616,-299814.475298989,653379.792895667,68.2336654663086,20,1.83399870191208,-1.0338093595061 +-158.7298,55.7964752,13.719616,-296110.520033865,653379.792997414,68.9931640625,20,1.83880606237484,-1.01634765414807 +-158.67083,55.7988255,13.719616,-292406.4063037,653379.786448842,70.5180969238281,20,1.84830058345383,-0.981860843583068 +-158.61185,55.8011464,13.719616,-288702.128356085,653379.77386335,76.1177215576172,20,1.8814857800122,-0.86132273768493 +-158.55287,55.8034378,13.719616,-284998.306194377,653379.787662876,104.679870605469,120,2.01986317713783,-0.358696534483265 +-158.49388,55.8056997,13.719616,-281294.309038973,653379.784455069,112.131019592285,120,2.04972577115172,-0.250227069391885 +-158.43488,55.8079322,13.719616,-277590.130358922,653379.776010625,108.54175567627,120,2.03559684206702,-0.301547372625391 +-158.37588,55.8101352,13.719616,-273886.390122797,653379.793115498,110.997543334961,120,2.0453133668238,-0.266254181336476 +-158.31687,55.8123087,13.719616,-270182.457545897,653379.794089964,134.226852416992,120,2.12783940622013,0.0335039490277451 +-158.25785,55.8144527,13.719616,-266478.326835929,653379.77962401,115.003875732422,120,2.06071247670875,-0.210320218890784 +-158.19882,55.8165673,13.719616,-262773.991494789,653379.761543661,96.8515167236328,120,1.98610642628948,-0.481310688700439 +-158.13979,55.8186524,13.719616,-259070.07144496,653379.768453771,86.2455291748047,120,1.93573659122314,-0.664268306643641 +-158.08075,55.820708,13.719616,-255365.935895236,653379.760958289,92.9663619995117,120,1.96832583628915,-0.545894866667273 +-158.02171,55.8227341,13.719616,-251662.204041,653379.777694505,99.2424468994141,120,1.99669746359909,-0.442841018208914 +-157.96266,55.8247307,13.719616,-247958.245087924,653379.780408229,102.948280334473,120,2.01261909648599,-0.385009103077229 +-157.9036,55.8266978,13.719616,-244254.053234238,653379.769868564,106.224304199219,120,2.02622389501286,-0.335592591631519 +-157.84454,55.8286354,13.719616,-240550.247670736,653379.783079248,113.417678833008,120,2.05468075492025,-0.232229154051409 +-157.78547,55.8305434,13.719616,-236846.198233535,653379.772371709,126.307899475098,120,2.10143051279731,-0.0624206897325551 +-157.72639,55.832422,13.719616,-233141.897836623,653379.760808614,122.585678100586,120,2.0884397337614,-0.109606907128474 +-157.66731,55.834271,13.719616,-229437.966926412,653379.76150512,116.73314666748,120,2.06719419255591,-0.186776776868014 +-157.60823,55.8360905,13.719616,-225734.399058883,653379.784750558,111.088409423828,21,2.04566874853704,-0.264963333517942 +-157.54913,55.8378805,13.719616,-222029.93843541,653379.762854827,106.324264526367,21,2.02663238726431,-0.334108831178962 +-157.49004,55.8396409,13.719616,-218326.454811834,653379.785847787,101.28409576416,21,2.00554125519113,-0.410717842877178 +-157.43093,55.8413718,13.719616,-214622.066787476,653379.765435362,102.969581604004,21,2.01270894807789,-0.384682736449248 +-157.37182,55.8430732,13.719616,-210918.018535975,653379.76769814,96.7211761474609,21,1.98552156898636,-0.483435057360239 +-157.31271,55.844745,13.719616,-207214.304797231,653379.780732876,85.1391296386719,21,1.93012920615291,-0.684635929725775 +-157.25359,55.8463873,13.719616,-203510.294184519,653379.784267904,96.008186340332,21,1.98230826565264,-0.49510669223642 +-157.19446,55.848,13.719616,-199805.981415381,653379.768098792,105.471649169922,21,2.02313573675476,-0.346809663873081 +-157.13533,55.8495831,13.719616,-196101.985634556,653379.762694121,105.694931030273,21,2.0240541596975,-0.343473689601021 +-157.0762,55.8511367,13.719616,-192398.300475392,653379.77846778,102.345092773438,121,2.01006702401358,-0.394278958731038 +-157.01706,55.8526607,13.719616,-188694.295627961,653379.77516754,108.855308532715,121,2.03684961307623,-0.296996950743482 +-156.95791,55.8541552,13.719616,-184989.964743076,653379.764908146,114.35188293457,220,2.05824332015712,-0.219288900253757 +-156.89876,55.8556201,13.719616,-181285.927476807,653379.76484696,149.2939453125,220,2.17404219506132,0.20132566568784 +-156.83961,55.8570554,13.719616,-177582.177973931,653379.774317615,172.395782470703,220,2.23652663694052,0.428286993428393 +-156.78045,55.8584611,13.719616,-173878.085384046,653379.766485005,181.807769775391,220,2.2596124393836,0.512141217245707 +-156.72129,55.8598373,13.719616,-170174.268387218,653379.779143545,201.715850830078,220,2.30474002641088,0.676057494024514 +-156.66212,55.8611839,13.719616,-166470.096607314,653379.775464818,211.205184936523,220,2.32470457561216,0.748574435173221 +-156.60295,55.8625008,13.719616,-162766.189615633,653379.769880866,221.141937255859,220,2.34467110979596,0.821098586345028 +-156.54377,55.8637882,13.719616,-159061.915674144,653379.760115195,242.147430419922,220,2.38407986483261,0.964242433016703 +-156.4846,55.865046,13.719616,-155358.519356123,653379.782905001,245.656814575195,220,2.39032881606439,0.986940407518767 +-156.42541,55.8662742,13.719616,-151654.119816822,653379.767497411,244.148544311523,220,2.38765413923101,0.977225217831159 +-156.36622,55.8674729,13.719616,-147949.960783884,653379.772374392,244.263748168945,220,2.3878590169594,0.977969392218593 +-156.30703,55.8686419,13.719616,-144246.037196922,653379.774712919,235.231750488281,220,2.37149594041101,0.918534027707819 +-156.24784,55.8697813,13.719616,-140542.34278366,653379.785119098,221.867340087891,220,2.34609337675416,0.826264665892621 +-156.18864,55.8708911,13.719616,-136838.246683832,653379.782469294,205.13005065918,220,2.31202928727947,0.702534170061417 +-156.12944,55.8719712,13.719616,-133134.368381787,653379.776838049,176.005950927734,121,2.24552735196975,0.4609801594744 +-156.07023,55.8730218,13.719616,-129430.076290974,653379.770524157,155.567581176758,121,2.19191909919004,0.266259684059789 +-156.01102,55.8740428,13.719616,-125725.989904014,653379.772513915,89.025634765625,121,1.94951507893967,-0.614220906485283 +-155.95181,55.8750341,13.719616,-122022.103678936,653379.771200996,81.6380920410156,22,1.91189284629218,-0.750875593915264 +-155.8926,55.8759958,13.719616,-118318.411398067,653379.77727432,71.3952713012695,22,1.85366944824994,-0.962359594216994 +-155.83338,55.8769279,13.719616,-114614.282196304,653379.773037341,57.9421615600586,22,1.76299469273338,-1.29171618740504 +-155.77416,55.8778304,13.719616,-110910.33519597,653379.776439136,43.6515808105469,22,1.63999997598812,-1.73846810481111 +-155.71493,55.8787033,13.719616,-107205.939530536,653379.770925594,26.7507362365723,22,1.42733573922008,-2.51092531316905 +-155.65571,55.8795465,11.97446626,-103502.33959287,653379.777799684,11.1350727081299,22,1.04669305717037,-3.89352818061167 +-155.53725,55.8811441,12.13038942,-96094.3775414595,653379.781572243,15.1171998977661,22,1.17947135587644,-3.41123950101166 +-155.47801,55.8818984,13.719616,-92390.0039262774,653379.768830124,25.0961284637451,22,1.39960672879109,-2.61164499369466 +-155.41878,55.8826231,13.719616,-88686.4022223474,653379.777045341,40.6281700134277,22,1.60882726114086,-1.85169630271499 +-155.35954,55.8833182,13.719616,-84982.3165653134,653379.778621494,56.1750526428223,22,1.74954348807784,-1.34057480207002 +-155.3003,55.8839836,13.719616,-81278.366290722,653379.77600959,58.2863731384277,22,1.76556703224563,-1.28237271607775 +-155.24105,55.8846194,13.719616,-77573.9202891236,653379.768368869,56.2262420654297,22,1.74993905799303,-1.33913797923117 +-155.18181,55.8852256,13.719616,-73870.2226709015,653379.779328983,78.4719772338867,22,1.89471459552943,-0.813271903846487 +-155.12256,55.8858021,13.719616,-70166.0177580441,653379.774664902,102.147117614746,22,2.00922611622865,-0.397333375824858 +-155.06331,55.886349,13.719616,-66461.9244576504,653379.77693882,119.257141113281,122,2.0764843940286,-0.153032113431697 +-155.00406,55.8868662,13.719616,-62757.9370590919,653379.774756442,148.965621948242,122,2.17308605417853,0.197852689091748 +-154.94481,55.8873538,13.719616,-59054.0494944285,653379.779026455,240.320983886719,221,2.38079169335211,0.952298855661953 +-154.88556,55.8878117,13.719616,-55350.2560323557,653379.778381301,418.297454833984,221,2.6214852220874,1.82656645280135 +-154.29296,55.8907603,13.719616,-18309.9452100474,653379.780224756,687.362121582031,320,2.83718559582395,2.61005177722868 +-154.2337,55.890892,13.719616,-14606.1718623553,653379.773793767,410.816925048828,320,2.61364832758322,1.79810061508976 +-154.17444,55.8909941,13.719616,-10902.4217483938,653379.773093042,383.801116943359,320,2.58410623429115,1.69079530010005 +-154.11517,55.8910666,13.719616,-7198.06399120854,653379.776992098,541.638061523438,320,2.73370917511727,2.23419588211106 +-154.05591,55.8911094,13.719616,-3494.34270538942,653379.777037179,604.073181152344,320,2.7810895549215,2.40629494526682 +-153.99664,55.8911225,13.719616,209.998010046121,653379.771598689,607.089904785156,330,2.78325301110956,2.41415323565374 +-153.81885,55.8909841,13.719616,11321.7957578964,653379.781214179,562.049682617188,231,2.74977470690859,2.29255047913645 +-153.75959,55.8908786,13.719616,15025.5482193611,653379.777166746,498.869476318359,231,2.69798693213713,2.10444249946396 +-153.70032,55.8907435,13.719616,18729.9495843722,653379.781675997,337.887878417969,231,2.52877261192697,1.48980778988513 +-153.64106,55.8905787,13.719616,22433.7558077956,653379.77857472,559.213500976562,231,2.74757764794657,2.28457013388333 +-160.0197,55.7042285,13.43838181,-377598.129316975,649675.767175545,31.6723117828369,12,1.50067976396829,-2.24451888081466 +-159.96097,55.7072227,13.719616,-373894.207800157,649675.781303311,68.5618133544922,12,1.836082295488,-1.02624115292154 +-159.90223,55.7101875,13.719616,-370190.246752111,649675.779597904,119.905250549316,112,2.07883820090259,-0.144482415022004 +-159.84348,55.713123,13.719616,-366486.239485758,649675.773503463,122.790336608887,112,2.08916418991124,-0.106975475611873 +-159.78472,55.7160293,13.719616,-362782.17935108,649675.774480629,122.809707641602,112,2.08923269749364,-0.106726636518591 +-159.72595,55.7189062,13.719616,-359078.062614016,649675.760699583,55.2328910827637,12,1.7421977763113,-1.36725652388096 +-159.49079,55.7301207,13.10250266,-344262.15814333,649675.769458574,66.4361190795898,12,1.8224042548518,-1.07592370061369 +-159.43198,55.732851,13.719616,-340558.294634636,649675.782476227,84.0434494018555,12,1.92450386888205,-0.705068760324661 +-159.31433,55.7382235,13.3019322,-333150.288474635,649675.779938222,45.578742980957,12,1.65876234357446,-1.67031783042465 +-159.25549,55.7408657,13.719616,-329446.134387222,649675.765316257,91.1099700927734,12,1.95956590407898,-0.577713440788193 +-159.19665,55.7434786,13.719616,-325742.496971857,649675.798892366,97.8282699584961,120,1.99046437332402,-0.465481381189045 +-159.13779,55.7460621,13.719616,-322038.120282867,649675.77140006,98.1643524169922,12,1.99195380592084,-0.460071336871028 +-159.07893,55.7486162,13.719616,-318334.249689082,649675.78089173,91.1846694946289,12,1.95992182831149,-0.57642062238482 +-159.02006,55.7511409,13.719616,-314630.253901945,649675.778842309,121.982276916504,120,2.08629673562149,-0.117390888045203 +-158.96118,55.7536362,13.719616,-310926.127182819,649675.765789108,117.428489685059,120,2.06977347520781,-0.177408086075744 +-158.9023,55.7561022,13.719616,-307222.488521099,649675.79965703,76.338134765625,20,1.8827415442574,-0.856761443515584 +-158.8434,55.7585387,13.719616,-303518.082724408,649675.765703211,69.9748306274414,20,1.84494185593911,-0.994060700592805 +-158.7845,55.7609458,13.719616,-299814.154320397,649675.767580792,76.1326293945312,20,1.88157082929175,-0.861013814426136 +-158.72559,55.7633236,13.719616,-296110.071218874,649675.77073459,78.696907043457,20,1.89595766399368,-0.808756724377252 +-158.66668,55.7656719,13.719616,-292406.454818312,649675.797565195,76.0107192993164,20,1.880874842337,-0.863541837700236 +-158.60775,55.7679907,13.719616,-288702.04823588,649675.760068601,81.2894897460938,20,1.91003439749632,-0.75762601039591 +-158.54882,55.7702802,13.719616,-284998.095268751,649675.768609546,90.0080032348633,20,1.95428112728607,-0.596909258525525 +-158.48988,55.7725402,13.719616,-281293.966147337,649675.757563976,106.24047088623,120,2.02628998693771,-0.335352526895973 +-158.43094,55.7747708,13.719616,-277590.279896019,649675.780502899,112.209808349609,120,2.05003082060939,-0.249119042691834 +-158.37199,55.7769719,13.719616,-273886.405939599,649675.784059398,117.765678405762,120,2.0710187382369,-0.172884935320617 +-158.31303,55.7791436,13.719616,-270182.337767006,649675.780033306,118.119071960449,120,2.07232002613558,-0.168158286248082 +-158.25406,55.7812859,13.719616,-266478.069618404,649675.769118572,120.522605895996,120,2.08106851326033,-0.136381283944146 +-158.19509,55.7833987,13.719616,-262774.221987664,649675.780467659,121.371589660645,120,2.08411704013648,-0.125308164193779 +-158.13611,55.785482,13.719616,-259070.163530278,649675.774115426,118.491981506348,120,2.07368896211513,-0.163185920037121 +-158.07713,55.7875358,13.719616,-255366.514003779,649675.789245621,119.437438964844,120,2.07714048246512,-0.150649012963977 +-158.01813,55.7895602,13.719616,-251662.015834796,649675.760264599,114.786460876465,120,2.05989066581979,-0.213305270607656 +-157.95913,55.7915551,13.719616,-247957.915023209,649675.75315402,116.922508239746,120,2.06789812333778,-0.184219899346394 +-157.90013,55.7935206,13.719616,-244254.205115982,649675.778137111,124.042991638184,120,2.09357223189847,-0.090964208933838 +-157.84112,55.7954565,13.719616,-240550.256079012,649675.775852804,124.825103759766,120,2.09630193573075,-0.081049145479933 +-157.7821,55.797363,13.719616,-236846.06081204,649675.769350099,125.218269348145,120,2.09766769707132,-0.0760883104638824 +-157.72308,55.7992399,13.719616,-233142.240342118,649675.772292484,124.987289428711,120,2.09686584971487,-0.0790008489325252 +-157.66405,55.8010874,13.719616,-229438.162053826,649675.771536381,120.902526855469,120,2.08243537768392,-0.131416442215731 +-157.60502,55.8029054,13.719616,-225734.446327131,649675.790782408,110.809875488281,120,2.0445784668811,-0.268923547689692 +-157.54598,55.8046938,13.719616,-222030.462397423,649675.784645701,101.084426879883,120,2.00468425310746,-0.413830719057846 +-157.48693,55.8064528,13.719616,-218326.203256261,649675.776247239,109.587379455566,21,2.0397605418454,-0.286423626592072 +-157.42788,55.8081822,13.719616,-214622.289824842,649675.77652225,105.281303405762,21,2.02235125296466,-0.349659132912695 +-157.36882,55.8098822,13.719616,-210918.089579814,649675.775187697,97.5764389038086,21,1.98934496429227,-0.469547394303515 +-157.30976,55.8115526,13.719616,-207214.223400172,649675.782087642,98.3989562988281,21,1.99299049196728,-0.456305797250688 +-157.25069,55.8131934,13.719616,-203510.059890187,649675.765819752,97.8164443969727,21,1.99041187227754,-0.465672079975162 +-157.19162,55.8148048,13.719616,-199806.217685678,649675.779662963,96.1903381347656,21,1.98313145139864,-0.492116646646318 +-157.13254,55.8163866,13.719616,-196102.066498838,649675.771094563,95.2368087768555,121,1.97880483450876,-0.507832154129801 +-157.07346,55.8179389,13.719616,-192398.225518243,649675.781173395,95.1943893432617,121,1.97861135228082,-0.508534936806973 +-157.01437,55.8194616,13.719616,-188694.063878661,649675.769649068,98.301025390625,220,1.9925580480373,-0.457876557036166 +-156.95528,55.8209548,13.719616,-184990.200786106,649675.776492569,100.156105041504,220,2.00067742696986,-0.428384655251639 +-156.89618,55.8224184,13.719616,-181286.005353217,649675.762594677,119.130546569824,220,2.0760231343271,-0.154707540324162 +-156.83708,55.8238525,13.719616,-177582.096803543,649675.766838471,159.520935058594,220,2.20281768666465,0.305846464534153 +-156.77798,55.8252571,13.719616,-173878.46931342,649675.788573614,181.283081054688,220,2.25835727377306,0.507582097488309 +-156.71887,55.8266321,13.719616,-170174.491962442,649675.79040273,218.830261230469,220,2.3401073787979,0.804521812741554 +-156.65975,55.8279775,13.719616,-166470.158895079,649675.773374029,220.378356933594,220,2.34316894078841,0.815642279747883 +-156.60063,55.8292934,13.719616,-162766.089370228,649675.774194816,226.9541015625,220,2.35593803581147,0.862023277534231 +-156.54151,55.8305797,13.719616,-159062.277986456,649675.781130907,248.279678344727,220,2.39494117406957,1.00369380829163 +-156.48238,55.8318364,13.719616,-155358.09333336,649675.770203995,253.130172729492,220,2.40334391548189,1.03421496348236 +-156.42325,55.8330636,13.719616,-151654.154696599,649675.776489472,249.547256469727,220,2.39715279958139,1.01172706341134 +-156.36412,55.8342612,13.719616,-147950.456642086,649675.788292089,244.484741210938,220,2.38825175910511,0.979395943791598 +-156.30498,55.8354292,13.719616,-144246.367756561,649675.783346915,236.792037963867,220,2.37436709532077,0.928962881849263 +-156.24584,55.8365676,13.719616,-140542.507729496,649675.783958393,226.881790161133,220,2.3557996402221,0.861520585251573 +-156.18669,55.8376765,13.719616,-136838.244778934,649675.780143276,212.929122924805,220,2.32823506519856,0.761398181053071 +-156.12754,55.8387557,13.719616,-133134.199336347,649675.770838892,192.317413330078,121,2.28401860909954,0.600791391868374 +-156.06839,55.8398054,13.719616,-129430.364812902,649675.777833316,161.585906982422,121,2.20840348028346,0.326135661301865 +-156.00923,55.8408255,13.719616,-125726.110157955,649675.770577997,94.3416519165039,121,1.97470347644584,-0.522729457258443 +-155.95007,55.841816,13.719616,-122022.055056791,649675.768655718,86.2489013671875,22,1.9357535717661,-0.664206628464887 +-155.89091,55.8427769,13.719616,-118318.1936421,649675.771615713,75.0059585571289,22,1.87509576560091,-0.884533093918433 +-155.83175,55.8437082,13.719616,-114614.520045837,649675.779020641,59.9922370910645,22,1.77809505693979,-1.23686735453433 +-155.77258,55.84461,13.719616,-110910.402549953,649675.78488759,35.9062232971191,22,1.55516972739068,-2.04659578068057 +-155.71341,55.8454821,12.60446585,-107206.461441614,649675.784339296,15.1286935806274,22,1.17980142668669,-3.41004058961722 +-155.53588,55.8479208,13.6211515,-96094.3847891098,649675.77820854,20.7790336608887,22,1.31762534661374,-2.90942477357893 +-155.4767,55.8486745,13.719616,-92390.4637415711,649675.779932383,24.8172740936279,22,1.39475407727917,-2.6292712090706 +-155.41751,55.8493986,13.719616,-88686.0638652404,649675.772293061,48.3493041992188,22,1.68439022847871,-1.57723003752581 +-155.35833,55.8500931,13.719616,-84982.4303905283,649675.782226854,65.3281173706055,22,1.81510014284711,-1.10245432021584 +-155.29914,55.850758,13.719616,-81278.3063400441,649675.783266935,55.0187911987305,22,1.74051104440539,-1.37338321560446 +-155.23995,55.8513932,13.719616,-77574.3115994034,649675.777320949,61.7125549316406,22,1.79037352680239,-1.19226844736913 +-155.18076,55.8519988,13.719616,-73870.4400658728,649675.775242882,94.6931304931641,22,1.97631847428179,-0.516863324152003 +-155.12156,55.8525749,13.719616,-70166.0601241553,649675.77733548,112.678161621094,22,2.05183975272332,-0.242548484933415 +-155.06237,55.8531213,13.719616,-66462.4173885439,649675.78273707,125.619529724121,122,2.09905716322343,-0.0710413728062986 +-155.00317,55.8536381,13.719616,-62758.2546811139,649675.781769473,164.277969360352,122,2.21557932590158,0.352200380777137 +-154.94397,55.8541252,13.719616,-59054.1918355424,649675.773618172,323.927886962891,221,2.51044833804649,1.42324879688274 +-154.88477,55.8545828,13.719616,-55350.2226481232,649675.780350183,618.980773925781,320,2.79167715967017,2.44475214771727 +-154.23349,55.8576605,13.719616,-14606.0695014339,649675.777247274,496.523956298828,420,2.69594020718668,2.09700821025045 +-154.17428,55.8577625,13.719616,-10902.1420584562,649675.774679953,596.218383789062,420,2.77540536293287,2.3856483375342 +-153.7598,55.8576471,13.719616,15025.8200956473,649675.780693624,663.493103027344,430,2.82183641275775,2.55429916323921 +-153.70059,55.857512,13.719616,18729.7738114325,649675.770650574,559.489013671875,430,2.74779156298497,2.28534713436022 +-161.59487,55.5793138,13.13344551,-477606.019512435,645971.753969746,15.7644920349121,12,1.1976799814278,-3.34510057574996 +-161.53648,55.5830929,13.719616,-473902.302180866,645971.783921644,22.8960380554199,12,1.35976033825555,-2.75637845741192 +-161.47807,55.586843,13.719616,-470198.0647411,645971.761951821,27.3999996185303,12,1.43775055677403,-2.4730957231282 +-161.41965,55.590564,13.719616,-466493.929023598,645971.748924075,25.6000003814697,12,1.40823997178334,-2.58028659097394 +-160.42486,55.6493646,6.649493098,-403526.324862316,645971.787259451,12.1476593017578,12,1.08449260301562,-3.75622944103722 +-160.07304,55.668104,13.719616,-381302.297341656,645971.783703516,76.4281921386719,12,1.88325358674074,-0.854901559064605 +-160.01437,55.6711249,13.719616,-377598.320950025,645971.787373169,37.1346855163574,12,1.56977975034428,-1.99352800719737 +-159.95569,55.6741165,13.719616,-373894.308349866,645971.783321791,99.8141479492188,12,1.99919210382038,-0.433779772883973 +-159.897,55.6770789,13.719616,-370190.252879526,645971.782984769,126.169952392578,112,2.10095593918817,-0.0641444765377448 +-159.8383,55.680012,13.719616,-366486.149871048,645971.775613817,125.053749084473,112,2.09709671631676,-0.0781622755386045 +-159.77959,55.6829158,13.719616,-362781.99364653,645971.761570723,95.5224227905273,12,1.98010532918744,-0.503108386258686 +-159.72088,55.6857903,13.65328805,-359078.404635448,645971.795299083,58.4575233459473,12,1.76684041177453,-1.27774743817011 +-159.48592,55.6969954,13.719616,-344262.092815163,645971.771451194,84.5210876464844,12,1.9269650770673,-0.696128949697065 +-159.42716,55.6997233,13.69085771,-340558.124967385,645971.764191639,97.8097457885742,12,1.99038213015904,-0.465780111838797 +-159.36839,55.702422,13.52611724,-336854.063179211,645971.76314111,69.0028991699219,12,1.83886733808578,-1.0161250832761 +-159.30961,55.7050913,13.719616,-333149.903565407,645971.746550814,77.3792037963867,12,1.88862425667736,-0.835393752912985 +-159.25083,55.7077313,13.719616,-329446.265629225,645971.775611378,90.8108291625977,12,1.9581376410886,-0.582901299636104 +-159.19204,55.710342,13.719616,-325742.517562452,645971.80009043,96.5831756591797,120,1.98490148092128,-0.485687394203385 +-159.13323,55.7129233,13.719616,-322038.028415418,645971.760889055,94.3265762329102,120,1.97463407115939,-0.52298155706908 +-159.07442,55.7154753,13.719616,-318334.043824526,645971.767173065,125.21215057373,120,2.09764647480954,-0.0761653957761021 +-159.0156,55.7179979,13.719616,-314629.93281657,645971.75931009,139.086456298828,120,2.14328484213399,0.089606180833229 +-158.95678,55.7204911,13.719616,-310926.315765228,645971.784658059,142.515121459961,120,2.1538609472793,0.128021613441931 +-158.89794,55.722955,13.719616,-307221.933892508,645971.760688347,90.9616088867188,20,1.95885813334683,-0.580284266105231 +-158.8391,55.7253894,13.719616,-303518.035329994,645971.758819429,73.8231506347656,20,1.86819257613591,-0.909607448421754 +-158.78025,55.7277945,13.719616,-299813.98659427,645971.755039006,76.814079284668,20,1.88544082934449,-0.846956869626602 +-158.7214,55.7301703,13.719616,-296110.408081156,645971.794528284,82.8452224731445,20,1.91826746853839,-0.7277211464187 +-158.66253,55.7325166,13.719616,-292406.043419508,645971.765928392,89.7262573242188,20,1.95291955276894,-0.601854885803809 +-158.60366,55.7348335,13.719616,-288702.138280153,645971.769589024,97.0949172973633,20,1.98719649615432,-0.47735124381443 +-158.54478,55.737121,13.719616,-284998.060804946,645971.761553254,100.318412780762,20,2.00138065221461,-0.425830340442221 +-158.4859,55.7393792,13.719616,-281294.430600939,645971.79593979,116.356811523438,120,2.06579181194981,-0.191870623508631 +-158.427,55.7416079,13.719616,-277589.991211207,645971.765898004,117.489280700684,120,2.06999824494899,-0.176591658220093 +-158.3681,55.7438071,13.719616,-273885.989071559,645971.756250859,123.38973236084,120,2.09127902222109,-0.0992938010292905 +-158.3092,55.745977,13.719616,-270182.416951838,645971.78824712,124.053520202637,120,2.09360909253317,-0.0908303205875217 +-158.25028,55.7481174,13.719616,-266478.018330955,645971.758417698,126.587608337402,120,2.10239119466962,-0.0589312189664216 +-158.19136,55.7502285,13.719616,-262774.038234041,645971.770522344,123.368606567383,120,2.09120465946126,-0.0995639077982309 +-158.13244,55.75231,13.719616,-259070.473009442,645971.790244026,123.10131072998,120,2.09026267713739,-0.102985456467054 +-158.0735,55.7543621,13.719616,-255366.06325075,645971.761982529,123.176231384277,120,2.09052691258059,-0.102025677917046 +-158.01456,55.7563848,13.719616,-251662.055413682,645971.763948616,121.245513916016,120,2.08366567867585,-0.126947637850191 +-157.95562,55.7583781,13.719616,-247958.443733312,645971.795230453,121.004699707031,120,2.08280223822714,-0.130083900010341 +-157.89666,55.7603418,13.719616,-244253.971531125,645971.759120771,125.305099487305,120,2.09796874564803,-0.074994816105456 +-157.83771,55.7622761,13.719616,-240550.510021321,645971.788992463,125.647491455078,120,2.09915382235086,-0.0706902792662206 +-157.77874,55.764181,13.719616,-236846.175105837,645971.775308888,128.528625488281,120,2.10899986313116,-0.0349266488123507 +-157.71977,55.7660564,13.719616,-233142.213856811,645971.779642188,129.265975952148,120,2.11148422943789,-0.0259027212775586 +-157.66079,55.7679023,13.719616,-229437.994362773,645971.766596309,127.164161682129,120,2.1043647325646,-0.0517627660280555 +-157.60181,55.7697187,13.719616,-225734.136929955,645971.771000268,121.236763000488,120,2.08363433226674,-0.127061496955226 +-157.54282,55.7715057,13.719616,-222030.009049843,645971.769728553,114.552467346191,120,2.05900444789727,-0.216524267054047 +-157.48383,55.7732631,13.719616,-218326.232224276,645971.774264466,91.5491027832031,120,1.96165409240382,-0.570128544764101 +-157.42483,55.7749911,13.63043548,-214622.173357677,645971.773753548,94.805046081543,21,1.97683145365712,-0.515000036641907 +-157.36583,55.7766896,13.719616,-210918.453345097,645971.789718121,101.880584716797,21,2.00809142881758,-0.401454884373887 +-157.30682,55.7783586,13.719616,-207214.440266937,645971.790187902,100.103713989258,21,2.00045019071727,-0.429210042180738 +-157.2478,55.7799981,13.719616,-203510.128311876,645971.776080799,94.3544082641602,21,1.97476219533377,-0.522516173497461 +-157.18878,55.781608,13.719616,-199806.138311795,645971.767282519,90.9972457885742,21,1.95902824773949,-0.579666362075618 +-157.12976,55.7831885,13.719616,-196102.463373166,645971.785327345,90.3610000610352,121,1.95598102878425,-0.590734731083954 +-157.07073,55.7847395,13.719616,-192398.472116215,645971.789397662,90.6354293823242,121,1.95729799654549,-0.585951128275091 +-157.01169,55.7862609,13.719616,-188694.159229957,645971.769331216,91.0102691650391,220,1.95909039880557,-0.57944061166395 +-156.95265,55.7877529,13.719616,-184990.143986212,645971.776233587,96.8832855224609,220,1.98624885825308,-0.480793335154491 +-156.89361,55.7892153,13.719616,-181286.421567011,645971.787162186,102.608787536621,220,2.01118455585611,-0.390219764103617 +-156.83456,55.7906482,13.719616,-177582.359537925,645971.785847992,123.069549560547,220,2.0901506110652,-0.103392512428095 +-156.7755,55.7920515,13.719616,-173877.952543833,645971.762180107,155.062713623047,220,2.19050737992501,0.261131916744394 +-156.71645,55.7934254,13.719616,-170174.446040848,645971.790714345,230.083221435547,220,2.36188494937859,0.883624165028107 +-156.65738,55.7947696,13.719616,-166469.957244618,645971.760548727,227.966293334961,220,2.35787063778644,0.869043039526821 +-156.59832,55.7960844,13.719616,-162766.357292686,645971.781353617,227.986740112305,220,2.35790958882713,0.869184520824337 +-156.53925,55.7973696,13.719616,-159062.389022769,645971.780685477,244.504501342773,220,2.38828685892112,0.979523436341836 +-156.48017,55.7986253,13.719616,-155358.046163113,645971.770770891,253.841415405273,220,2.4045624807004,1.03864114016913 +-156.42109,55.7998514,13.719616,-151653.949402595,645971.76441213,251.227172851562,220,2.40006661110523,1.02231085855054 +-156.36201,55.801048,13.719616,-147950.092487357,645971.77219004,245.51872253418,220,2.39008461573902,0.98605340223531 +-156.30293,55.802215,13.719616,-144246.469975037,645971.782423925,239.928497314453,220,2.38008183400951,0.949720443915591 +-156.24384,55.8033525,13.719616,-140542.449520214,645971.784559632,232.583053588867,220,2.36657806808393,0.90067091171534 +-156.18474,55.8044604,13.719616,-136838.025658927,645971.768615671,222.747421264648,220,2.34781268493331,0.832509683938691 +-156.12565,55.8055388,13.719616,-133134.444392496,645971.786995032,214.719879150391,220,2.33187225405739,0.774609489145417 +-156.06655,55.8065876,13.719616,-129430.448016345,645971.787417314,182.749313354492,121,2.26185575385471,0.520289575710486 +-156.00744,55.8076068,13.719616,-125726.0306677,645971.771079038,107.682655334473,121,2.03214575623067,-0.314082701420973 +-155.94834,55.8085965,13.719616,-122022.438375185,645971.787077916,92.1002807617188,22,1.96426095411736,-0.560659678948093 +-155.88923,55.8095566,13.719616,-118318.413402112,645971.786519163,81.4263229370117,22,1.91076482329558,-0.754972895408749 +-155.83011,55.8104871,13.719616,-114613.949883402,645971.770639513,54.4148483276367,22,1.73571742298608,-1.39079501683516 +-155.771,55.811388,13.719616,-110910.29417236,645971.774090234,19.5673313140869,22,1.29153159854522,-3.00420471446098 +-155.53451,55.8146961,11.42965527,-96094.2391340091,645971.778407754,15.6434211730957,22,1.1943317381174,-3.35726235113711 +-155.47538,55.8154491,13.719616,-92390.1514856922,645971.769662649,29.7235641479492,22,1.47310088439472,-2.34469324322182 +-155.41625,55.8161726,13.719616,-88686.2101089353,645971.773549454,50.837329864502,22,1.70618273197706,-1.49807344462003 +-155.35712,55.8168665,13.719616,-84982.4093910074,645971.778596959,62.3661575317383,22,1.79494898737053,-1.17564906861921 +-155.29798,55.8175308,13.719616,-81278.117351573,645971.772250834,61.2017478942871,22,1.786763825577,-1.20537991253108 +-155.23884,55.8181655,13.719616,-77573.9542288967,645971.767563029,86.1342468261719,22,1.93517586051819,-0.666305040612506 +-155.1797,55.8187707,13.719616,-73869.9139532124,645971.77538819,112.517784118652,122,2.05122117075127,-0.244795351216785 +-155.12056,55.8193462,13.719616,-70165.991058114,645971.773164383,121.869781494141,122,2.08589603246601,-0.118846356277972 +-155.06142,55.8198921,13.719616,-66462.1794629849,645971.771772968,134.518692016602,122,2.12878263583012,0.0369300281957906 +-155.00228,55.8204085,13.719616,-62758.4731264833,645971.782109488,204.167984008789,221,2.30998764050092,0.695118326217709 +-161.6465,55.5424802,11.89870577,-481309.935492635,642267.748364237,17.0333576202393,12,1.23130026465155,-3.22298211089707 +-161.58817,55.5462852,13.70355598,-477606.068317586,642267.763068803,23.4006080627441,12,1.36922714266071,-2.72199232171737 +-161.52983,55.5500611,13.719616,-473902.312396033,642267.782827705,32.3656158447266,12,1.51008387507778,-2.21036046506445 +-161.47147,55.5538081,13.719616,-470198.033013831,642267.758988069,29.1977920532227,12,1.46535001119647,-2.37284662699733 +-160.36061,55.6194711,10.1567477,-399821.912646503,642267.746684001,35.2787590026855,12,1.54751329959569,-2.07440611179402 +-160.30204,55.6226355,13.61965639,-396117.959201766,642267.747463958,39.0089683532715,12,1.59116446493866,-1.91585261998536 +-160.24346,55.6257708,13.7190887,-392413.994335095,642267.758539938,23.8027248382568,12,1.3766266761524,-2.69511510403845 +-160.18487,55.6288768,13.719616,-388710.014518044,642267.758005009,98.60205078125,12,1.99388594773754,-0.453053246304571 +-160.12627,55.6319536,13.719616,-385006.013062404,642267.757242167,58.1658325195312,12,1.76466794847074,-1.28563844497222 +-160.06766,55.6350012,13.719616,-381301.984333428,642267.756554983,57.5699806213379,12,1.76019608326706,-1.3018815357894 +-160.00904,55.6380195,13.719616,-377597.923700936,642267.745162795,47.3613052368164,12,1.67542366266199,-1.60979916388482 +-159.95042,55.6410087,13.719616,-373894.450169545,642267.801887364,105.900253295898,112,2.02489699886933,-0.340412257158694 +-159.89178,55.6439685,13.719616,-370190.3077543,642267.780619148,132.023498535156,112,2.12065123708381,0.00739446701690677 +-159.83313,55.6468992,13.719616,-366486.114487739,642267.771863675,127.911231994629,112,2.10690868192284,-0.0425224158434958 +-159.77448,55.6498005,13.719616,-362782.494323632,642267.79731586,121.098129272461,112,2.08313743420067,-0.128866372560025 +-159.71581,55.6526726,12.50398737,-359078.186304927,642267.769741677,36.662281036377,12,1.56421948219448,-2.01372448817597 +-159.48106,55.6638683,13.719616,-344262.11575498,642267.766848954,71.5280609130859,12,1.8544764517163,-0.959428327285477 +-159.42235,55.666594,13.719616,-340558.047239631,642267.761387198,96.95556640625,12,1.98657274781515,-0.479616875817769 +-159.36364,55.6692904,13.719616,-336854.51109268,642267.799124197,107.269111633301,12,2.03047468395649,-0.320152512892303 +-159.30491,55.6719575,13.719616,-333150.248287581,642267.778523765,106.154197692871,120,2.02593717230141,-0.336634050358317 +-159.24618,55.6745953,13.719616,-329446.50646496,642267.800953067,93.4593887329102,120,1.97062293621331,-0.537551144085142 +-159.18743,55.6772038,13.719616,-325742.026594308,642267.767132567,104.199340820312,120,2.01786497156421,-0.365954587471304 +-159.12868,55.6797829,13.719616,-322038.057172008,642267.765114287,80.6713333129883,12,1.90671923489869,-0.769667627192135 +-159.06992,55.6823327,13.719616,-318333.964951613,642267.756917685,108.030372619629,120,2.03354587406715,-0.308997073805443 +-159.01116,55.6848532,13.719616,-314630.370898684,642267.790450089,144.579666137695,120,2.16010721754248,0.150709849900818 +-158.95238,55.6873443,13.719616,-310926.016805214,642267.759833256,148.0556640625,120,2.17042502654488,0.188187077193421 +-158.8936,55.6898061,13.719616,-307222.149450429,642267.770929515,145.10383605957,120,2.16167889388144,0.156418626965038 +-158.83481,55.6922385,13.719616,-303518.137270228,642267.765818841,90.0821838378906,20,1.95463890611794,-0.595609703687928 +-158.77601,55.6946416,13.719616,-299813.973725239,642267.756196395,78.8744201660156,20,1.89693617961035,-0.805202476361372 +-158.71721,55.6970153,13.719616,-296110.280562629,642267.776130201,86.1792373657227,20,1.93540264652511,-0.665481289104219 +-158.6584,55.6993597,13.719616,-292406.424591819,642267.791639898,93.4610748291016,120,1.97063077122782,-0.537522685076114 +-158.59958,55.7016747,13.719616,-288702.400869449,642267.792230508,110.243499755859,120,2.04235299175996,-0.277007108543521 +-158.54075,55.7039603,13.719616,-284998.203649726,642267.778534605,119.42227935791,120,2.07708535610313,-0.150849247645337 +-158.48192,55.7062165,13.719616,-281294.453852415,642267.793554345,123.300445556641,120,2.09096464595859,-0.100435705346584 +-158.42308,55.7084433,13.719616,-277590.519060995,642267.794476328,121.259689331055,120,2.0837164512321,-0.126763217433939 +-158.36423,55.7106408,13.719616,-273886.392792773,642267.793091726,120.14379119873,120,2.07970133221189,-0.141347275744431 +-158.30537,55.7128088,13.719616,-270182.070768576,642267.767846948,123.037605285645,120,2.09003786974806,-0.103802021071492 +-158.24651,55.7149474,13.719616,-266478.173159848,642267.770684143,127.072463989258,120,2.10405145115883,-0.0529006935132214 +-158.18764,55.7170567,13.719616,-262774.066841248,642267.772194614,125.882446289062,120,2.09996517402127,-0.0677432184164501 +-158.12877,55.7191365,13.719616,-259070.374136918,642267.789869992,122.845069885254,120,2.08935773171888,-0.106272476524208 +-158.06989,55.7211869,13.719616,-255366.461908481,642267.795442554,121.75178527832,120,2.08547533810711,-0.120374438267609 +-158.011,55.7232078,13.719616,-251662.325068015,642267.778538899,121.536682128906,120,2.08470737622081,-0.123163895036803 +-157.9521,55.7251994,13.719616,-247957.956498286,642267.762168471,122.05948638916,120,2.08657153816831,-0.116392726758678 +-157.8932,55.7271615,13.719616,-244253.978438386,642267.761639203,124.174774169922,120,2.09403337883963,-0.0892891916190868 +-157.8343,55.7290942,13.719616,-240550.384450582,642267.787190696,127.056373596191,120,2.10399645567704,-0.0531004528003523 +-157.77538,55.7309974,13.719616,-236845.916066898,642267.755499064,131.676559448242,120,2.11950847041859,0.00324361231074953 +-157.71647,55.7328712,13.719616,-233142.446868292,642267.785495623,132.949813842773,120,2.12368773356595,0.0184238889424134 +-157.65754,55.7347156,13.719616,-229438.091083455,642267.771018154,131.483093261719,120,2.11886991271027,0.000924188451598255 +-157.59861,55.7365305,13.719616,-225734.096879694,642267.771435117,126.898361206055,120,2.10345601355441,-0.0550634928472905 +-157.53968,55.7383159,13.719616,-222030.458455175,642267.785926694,120.469314575195,120,2.08087643937762,-0.137078951109523 +-157.48073,55.7400719,13.719616,-218325.916088305,642267.759064975,95.5284805297852,120,1.98013286993901,-0.503008350388049 +-157.42179,55.7417984,13.719616,-214622.344579985,642267.779227095,94.1430358886719,21,1.97378819915901,-0.526054005610358 +-157.36284,55.7434955,13.719616,-210918.484225716,642267.791570379,96.2327575683594,21,1.98332293076515,-0.491421138933497 +-157.30388,55.7451631,13.719616,-207214.329802153,642267.785872294,98.1714782714844,21,1.99198533067386,-0.459956829969983 +-157.24492,55.7468012,13.719616,-203510.502168165,642267.793696292,87.0016708374023,21,1.93952759317605,-0.650498305491012 +-157.18595,55.7484098,13.719616,-199806.368846775,642267.78421548,84.0138397216797,21,1.92435083391508,-0.705624627005193 +-157.12697,55.7499889,13.719616,-196101.92402707,642267.758375774,84.711540222168,21,1.92794257813957,-0.692578386796004 +-157.068,55.7515386,13.719616,-192398.414716865,642267.786210165,86.0223159790039,121,1.93461113088677,-0.668356299823693 +-157.00901,55.7530588,13.719616,-188693.955635387,642267.768974077,86.5886688232422,121,1.9374610630391,-0.658004532794817 +-156.95003,55.7545494,13.719616,-184990.421464916,642267.781759082,91.7681045532227,220,1.9626917615553,-0.566359434225649 +-156.89103,55.7560106,13.719616,-181285.925388327,642267.762590838,94.4133453369141,220,1.9750333862106,-0.521531130827227 +-156.83204,55.7574423,13.719616,-177582.342095519,642267.783241482,102.724975585938,220,2.01167604671761,-0.388434529009168 +-156.77304,55.7588445,13.719616,-173878.412434071,642267.789025769,151.713104248047,220,2.18102309467483,0.226682285631209 +-156.71403,55.7602171,13.719616,-170174.131040386,642267.769847367,218.987503051758,220,2.34041933168706,0.805654914675198 +-156.65502,55.7615603,13.719616,-166470.117841277,642267.774094461,231.714263916016,220,2.3649527690051,0.89476736155449 +-156.59601,55.7628739,13.719616,-162766.367916473,642267.778888687,229.876510620117,220,2.36149459619644,0.882206290852644 +-156.53699,55.7641581,13.719616,-159062.247895739,642267.781955439,238.529449462891,220,2.37754200580661,0.940495062943517 +-156.47797,55.7654127,13.719616,-155358.379484517,642267.785507978,246.545028686523,220,2.39189624987759,0.992633774518476 +-156.41894,55.7666378,13.719616,-151654.129756038,642267.777278355,250.280410766602,220,2.39842685908126,1.01635481116766 +-156.35991,55.7678333,13.719616,-147950.119948625,642267.769525641,247.092239379883,220,2.39285910538824,0.996131140559464 +-156.30088,55.7689994,13.719616,-144246.343434689,642267.783982777,244.467727661133,220,2.38822153575511,0.979286163957784 +-156.24184,55.7701359,13.719616,-140542.168502184,642267.776684054,238.337326049805,220,2.37719206260676,0.939223969357934 +-156.1828,55.7712429,13.719616,-136838.215594871,642267.780530055,232.910629272461,220,2.36718930875383,0.902891112293892 +-156.12376,55.7723203,13.719616,-133134.479240635,642267.783880532,231.156677246094,220,2.36390644308775,0.890966807171522 +-156.06471,55.7733682,13.719616,-129430.326566761,642267.777896214,198.251754760742,220,2.2972170400226,0.648731860188194 +-156.00566,55.7743866,13.719616,-125726.378410457,642267.782707088,131.870635986328,121,2.12014810071065,0.00556693210016472 +-155.9466,55.7753754,13.719616,-122022.002600165,642267.768338199,100.180221557617,22,2.00078198783607,-0.428004860340921 +-155.88755,55.7763347,13.719616,-118318.446292408,642267.782785879,87.4800338745117,22,1.94190894253559,-0.641848564912373 +-155.82849,55.7772644,13.719616,-114614.450627018,642267.778285255,61.5041809082031,22,1.78890463908673,-1.19760386681473 +-155.76942,55.7781646,13.719616,-110910.00944428,642267.767227917,48.482250213623,22,1.68558276859801,-1.57289839142767 +-155.53314,55.7814699,12.42266765,-96093.9408130939,642267.771923915,41.6575546264648,22,1.61969377249116,-1.81222603187959 +-155.47407,55.7822223,13.719616,-92390.3185524381,642267.777883429,40.0711517333984,22,1.60283182519465,-1.87347343733944 +-155.41499,55.7829452,13.719616,-88686.2157025106,642267.779499128,54.1903915405273,22,1.73392228892116,-1.39731545614123 +-155.35591,55.7836385,13.719616,-84982.2533206208,642267.779770553,59.3108139038086,22,1.77313388376201,-1.25488775157584 +-155.29683,55.7843022,13.719616,-81278.4255389817,642267.778382653,82.4777145385742,22,1.91633661812127,-0.734734546253253 +-155.23774,55.7849364,13.719616,-77574.0996142985,642267.774495644,113.401252746582,122,2.0546178522458,-0.232457634519232 +-155.17866,55.785541,13.719616,-73870.5232398754,642267.780598612,122.35871887207,122,2.08763492115913,-0.112530216216299 +-155.11957,55.7861161,13.719616,-70166.4370239852,642267.784755739,142.935134887695,122,2.15513899584696,0.132663850631051 +-155.06048,55.7866615,13.719616,-66462.4621498443,642267.776100642,171.361343383789,122,2.23391285814394,0.418793002792487 +-155.00138,55.7871774,13.719616,-62757.9657141814,642267.767221772,247.332489013672,221,2.39328116800952,0.997664192468622 +-161.63976,55.5094528,12.50106524,-481309.906963768,638563.739279856,24.9802799224854,12,1.3975973006558,-2.61894381022995 +-161.58148,55.5132547,13.719616,-477606.006901127,638563.757622793,58.4262161254883,12,1.76660776087757,-1.27859249263305 +-161.52319,55.5170275,13.719616,-473902.216564783,638563.778268184,44.4773941040039,12,1.64813933434279,-1.70890363206279 +-161.46488,55.5207713,12.43584905,-470197.901937265,638563.741495218,23.6698093414307,12,1.37419475973314,-2.70394851861126 +-160.35499,55.5863796,13.719616,-399822.004628332,638563.76187599,90.0138778686523,12,1.954309471852,-0.596806302971731 +-160.29647,55.5895413,13.719616,-396117.980336222,638563.749759003,179.656921386719,12,2.25444395330886,0.493367800589462 +-160.23794,55.592674,13.719616,-392413.942183566,638563.756352734,132.576599121094,12,2.12246687422378,0.0139893793437049 +-160.17941,55.5957774,13.719616,-388710.514932165,638563.807194025,63.9901809692383,12,1.8061133383896,-1.1350969590949 +-160.12086,55.5988516,13.719616,-385006.437447346,638563.796048495,92.6486663818359,112,1.96683917230923,-0.551294854578504 +-160.0623,55.6018966,13.719616,-381302.331322016,638563.782311066,158.171783447266,112,2.19912901148708,0.292448143436473 +-160.00373,55.6049125,13.719616,-377598.189915909,638563.777397101,155.562164306641,112,2.19190397677352,0.266204755126624 +-159.94515,55.6078991,13.719616,-373894.009613984,638563.759446134,152.703536987305,112,2.18384909649505,0.236947130863496 +-159.88657,55.6108565,13.719616,-370190.410986777,638563.79564016,120.396896362305,112,2.08061529165521,-0.138027514176281 +-159.82797,55.6137847,13.719616,-366486.133943213,638563.774293838,127.386817932129,112,2.10512448925887,-0.0490031128583105 +-159.76937,55.6166836,13.43971879,-362782.42825691,638563.795603435,51.4444007873535,12,1.7113381130249,-1.47934762916201 +-159.71075,55.6195533,9.675090628,-359078.032846145,638563.761238279,46.5607376098633,12,1.66801985173968,-1.63669191841265 +-159.65213,55.6223938,8.232848064,-355374.196513509,638563.780289245,18.7931137084961,12,1.27399874148359,-3.06788905568446 +-159.5935,55.625205,7.586521722,-351670.287321748,638563.787434579,11.047999382019,12,1.04328364127788,-3.90591215227739 +-159.53486,55.6279869,13.35548845,-347966.299589794,638563.783092172,58.4636726379395,12,1.76688609388648,-1.27758150770052 +-159.47621,55.6307396,13.719616,-344262.226716756,638563.778797248,72.1034317016602,12,1.85795593508874,-0.946789850533315 +-159.41755,55.633463,13.719616,-340558.063954791,638563.763890525,102.387153625488,120,2.01024546973015,-0.393630792954978 +-159.35889,55.6361571,13.719616,-336854.432841696,638563.789550935,82.2654418945312,120,1.91521743489106,-0.738799739192067 +-159.30021,55.638822,13.719616,-333150.072349838,638563.765351668,92.0801620483398,120,1.96416607492058,-0.561004307272017 +-159.24153,55.6414576,13.719616,-329446.232145988,638563.781556821,87.4324417114258,12,1.94167260702835,-0.64270700293154 +-159.18284,55.6440638,13.719616,-325742.280180612,638563.776829939,103.022811889648,120,2.01293339927677,-0.383867465630158 +-159.12414,55.6466408,13.719616,-322038.209011333,638563.773895167,73.1995544433594,12,1.8645084375696,-0.922989291252422 +-159.06543,55.6491885,13.719616,-318334.01381958,638563.7621652,87.2797012329102,12,1.94091325094966,-0.645465200951123 +-159.00672,55.6517069,13.719616,-314630.316131392,638563.7895496,131.220260620117,120,2.11800089598618,-0.00223232833233977 +-158.948,55.6541959,13.719616,-310926.483850281,638563.796991216,150.348281860352,120,2.17709846946459,0.212426926668074 +-158.88927,55.6566556,13.719616,-307222.510424426,638563.79615947,152.815826416016,120,2.18416833440468,0.238106694070817 +-158.83053,55.659086,13.719616,-303518.390149236,638563.787626444,135.914245605469,120,2.13326497890767,0.053211177641533 +-158.77178,55.6614871,13.719616,-299814.117318291,638563.77197718,87.0143585205078,20,1.93959092286804,-0.650268273973596 +-158.71303,55.6638588,13.719616,-296110.314238518,638563.78328227,84.8188323974609,20,1.92849228973616,-0.690581677373849 +-158.65427,55.6662012,13.719616,-292406.347165112,638563.787562954,91.4370803833008,20,1.96112235043988,-0.572059983351376 +-158.5955,55.6685142,13.719616,-288702.211156762,638563.77432678,101.968765258789,120,2.00846716045658,-0.400090119816571 +-158.53672,55.6707979,13.719616,-284997.899709849,638563.755325351,123.518341064453,120,2.0917314501598,-0.0976504536201074 +-158.47794,55.6730522,13.719616,-281294.035084963,638563.762447245,126.394721984863,120,2.10172893897241,-0.0613367206852844 +-158.41915,55.6752772,13.719616,-277589.983569713,638563.763999452,128.080612182617,120,2.10748339469901,-0.0404348950010888 +-158.36036,55.6774728,13.719616,-273886.367401632,638563.790779656,128.648391723633,120,2.10940436132042,-0.033457395933656 +-158.30155,55.679639,13.719616,-270181.926380899,638563.760434645,131.042617797852,120,2.11741256026956,-0.00436933158283203 +-158.24274,55.6817758,13.719616,-266477.909206171,638563.755588468,131.602890014648,120,2.11926542653959,0.00236080757057829 +-158.18393,55.6838833,13.719616,-262774.309422867,638563.786401652,127.143028259277,120,2.10429255112961,-0.0520249496025767 +-158.12511,55.6859613,13.719616,-259070.49546431,638563.790675245,125.227172851562,120,2.09769857599147,-0.0759761494121805 +-158.06628,55.68801,13.719616,-255366.460181043,638563.791390764,125.563140869141,120,2.09886217071927,-0.0717496412378087 +-158.00744,55.6900293,13.719616,-251662.198516891,638563.778179039,125.919937133789,120,2.10009449819117,-0.0672734761185961 +-157.9486,55.6920191,13.719616,-247958.332599778,638563.778018328,126.55004119873,120,2.10226229088012,-0.0593994343227105 +-157.88975,55.6939796,13.719616,-244254.228109734,638563.775480842,125.958686828613,120,2.10022812428858,-0.0667881079921229 +-157.8309,55.6959107,13.719616,-240550.507181543,638563.796456149,128.196136474609,120,2.10787493678154,-0.0390127024001128 +-157.77203,55.6978123,13.719616,-236845.910234004,638563.757622487,134.699691772461,120,2.12936660194665,0.0390511598115343 +-157.71317,55.6996845,13.719616,-233142.312524747,638563.777912401,134.832870483398,120,2.12979578039908,0.0406100584504837 +-157.6543,55.7015273,13.719616,-229438.453837119,638563.785713552,133.170028686523,120,2.12440649329761,0.0210346294422734 +-157.59542,55.7033407,13.719616,-225734.328403135,638563.78186946,127.225982666016,120,2.10457581395508,-0.0509960581692151 +-157.53653,55.7051246,13.719616,-222029.931046568,638563.756109172,116.89958190918,120,2.06781295791239,-0.184529244480063 +-157.47765,55.7068792,13.719616,-218326.509250633,638563.797307236,95.385383605957,120,1.97948183062016,-0.505373111019269 +-157.41875,55.7086042,13.719616,-214622.177317986,638563.772663802,96.2110290527344,21,1.98322485979449,-0.491777360691187 +-157.35985,55.7102998,13.719616,-210918.182739055,638563.770522595,95.435173034668,21,1.979708465266,-0.504549909297597 +-157.30095,55.711966,13.719616,-207214.519739186,638563.790119704,94.4694747924805,21,1.97529150088218,-0.520593584666792 +-157.24203,55.7136027,13.719616,-203509.928636187,638563.758285954,90.5090637207031,21,1.95669207231885,-0.588152018014223 +-157.18312,55.71521,13.719616,-199806.28476445,638563.779018351,84.3063278198242,21,1.92586017289396,-0.700142277025662 +-157.1242,55.7167878,13.719616,-196102.328419564,638563.779730861,82.9964065551758,21,1.91905928939966,-0.724845027042377 +-157.06527,55.7183362,13.719616,-192398.053278144,638563.77251579,85.3356781005859,121,1.93113064385963,-0.680998422136166 +-157.00634,55.7198551,13.719616,-188694.08128874,638563.775629096,87.3859252929688,121,1.94144148915811,-0.643546489003864 +-156.94741,55.7213445,13.719616,-184990.406639788,638563.788384525,88.7310409545898,121,1.94807557650578,-0.619449590200058 +-156.88847,55.7228044,13.719616,-181286.396293554,638563.782811469,91.6807861328125,220,1.96227832857269,-0.567861140824014 +-156.82952,55.7242349,13.719616,-177582.043961563,638563.771057002,98.2307510375977,220,1.99224746452155,-0.45900468501473 +-156.77057,55.7256359,13.719616,-173877.971548338,638563.769197203,164.074371337891,220,2.21504074890331,0.350244115394263 +-156.71162,55.7270074,13.719616,-170174.173237894,638563.776598744,223.174896240234,220,2.34864534153124,0.835534130366236 +-156.65266,55.7283494,13.719616,-166470.015988151,638563.76757499,233.445785522461,220,2.36818603786905,0.906511516935176 +-156.5937,55.7296619,13.719616,-162766.121206068,638563.767701279,225.159744262695,220,2.3524907467151,0.84950173958193 +-156.53474,55.730945,13.719616,-159062.482647336,638563.787519908,233.221862792969,220,2.36776925983181,0.904997660143617 +-156.47577,55.7321985,13.719616,-155358.468127205,638563.780786122,241.742523193359,220,2.3833530507547,0.961602436832357 +-156.41679,55.7334226,13.719616,-151654.070984075,638563.770878056,242.255432128906,220,2.38427352408053,0.964945858680993 +-156.35781,55.7346172,13.719616,-147949.91304624,638563.770057512,243.780242919922,220,2.38699850547209,0.974843768882272 +-156.29883,55.7357822,13.719616,-144245.988876486,638563.766646823,249.795791625977,220,2.39758511742878,1.01329736522887 +-156.23985,55.7369178,13.719616,-140542.291869794,638563.782393073,244.508605957031,220,2.38829414956956,0.97954991805791 +-156.18086,55.7380238,13.719616,-136838.189737933,638563.773902911,241.313720703125,220,2.38258201588412,0.958801818107118 +-156.12187,55.7391003,13.719616,-133134.303494748,638563.773533348,239.623107910156,220,2.3795286966637,0.947711291194486 +-156.06287,55.7401474,13.719616,-129429.999742771,638563.772446615,224.042678833008,220,2.35033075679905,0.841656039684339 +-156.00387,55.7411649,13.719616,-125725.90058198,638563.768496679,173.183868408203,121,2.23850743625188,0.435481821903687 +-155.94487,55.7421529,13.719616,-122021.999828455,638563.772361314,107.850341796875,22,2.03282152579704,-0.311628113472082 +-155.88587,55.7431114,13.719616,-118318.291653499,638563.78359333,98.3188095092773,22,1.99263661126691,-0.457591192962054 +-155.82686,55.7440403,13.719616,-114614.14330917,638563.773360718,77.5577774047852,22,1.8896253548849,-0.831757478481309 +-155.76785,55.7449397,13.719616,-110910.175864034,638563.770755977,64.5270462036133,22,1.80974178525539,-1.12191740441649 +-155.70884,55.7458096,13.719616,-107206.383487246,638563.775371915,48.7411842346191,22,1.6878960767632,-1.56449579588781 +-155.64982,55.74665,13.719616,-103502.133122257,638563.771229584,40.4595108032227,22,1.60702062740302,-1.85825851211546 +-155.5908,55.7474609,12.31586212,-99798.0461619263,638563.774649026,48.3331527709961,22,1.6842451250869,-1.57775709446148 +-155.53178,55.7482422,13.719616,-96094.1170304787,638563.774121896,40.9024124145508,22,1.61174892334794,-1.84108399165348 +-155.47276,55.748994,13.719616,-92390.3396176876,638563.780435035,51.1095733642578,22,1.70850225570926,-1.48964827236669 +-155.41373,55.7497162,13.719616,-88686.0811017527,638563.768752215,61.9024047851562,22,1.79170752082363,-1.18742300032422 +-155.3547,55.750409,13.719616,-84981.962388827,638563.775498942,93.2573547363281,22,1.96968309244263,-0.54096492491836 +-155.29567,55.7510721,13.719616,-81277.9783257529,638563.766935968,122.266716003418,122,2.08730824752375,-0.113716788101948 +-155.23664,55.7517058,13.719616,-77574.1223949978,638563.776188366,134.192123413086,122,2.12772702508317,0.0330957486615384 +-155.17761,55.7523099,13.719616,-73870.3891853731,638563.780684876,158.428527832031,122,2.19983338662528,0.295006634987095 +-155.11857,55.7528844,13.719616,-70166.1456055736,638563.769585802,192.049270629883,122,2.28341266212854,0.598590419515224 +-155.05953,55.7534295,13.719616,-66462.0126583123,638563.776596806,244.231338500977,221,2.38780138960402,0.977760073215377 +-155.00049,55.7539449,13.719616,-62757.9850395162,638563.768042653,318.441467285156,221,2.50302961635366,1.39630188218042 +-154.23287,55.7579572,13.719616,-14606.2491300329,638563.779461419,692.915893554688,420,2.84068052294971,2.62274635010096 +-154.17382,55.7580589,13.719616,-10902.4503798064,638563.772476121,682.927490234375,420,2.83437459495124,2.59984141971945 +-161.63304,55.4764236,13.69169049,-481310.390834291,634859.800150248,41.0408515930176,12,1.61321636375852,-1.83575382923306 +-161.57481,55.4802223,13.719616,-477606.464598563,634859.81051952,52.750358581543,12,1.72222541618691,-1.4398018365319 +-161.51656,55.4839919,13.6618887,-473902.018760673,634859.749074279,36.5124855041504,12,1.56244139756206,-2.02018299907681 +-160.69998,55.5337195,11.13166063,-422046.047549845,634859.761662834,31.1000003814697,12,1.49276039435385,-2.27328429166744 +-160.64157,55.5370534,12.47221311,-418341.922253518,634859.746068969,49.5047149658203,12,1.69464656430976,-1.53997609833772 +-160.58316,55.5403582,9.143847673,-414638.44411493,634859.796396337,32.3022842407227,12,1.50923323434549,-2.21345023500117 +-160.34938,55.5532862,12.91642145,-399822.104640054,634859.762829681,76.2495422363281,112,1.88223724074232,-0.858593217824899 +-160.29091,55.5564454,13.719616,-396118.012857313,634859.759922039,148.917465209961,112,2.17294563529081,0.197342647612019 +-160.23243,55.5595754,13.719616,-392413.907949308,634859.750862174,184.680465698242,112,2.26642096101622,0.536871711160919 +-160.17395,55.5626762,13.719616,-388710.41207388,634859.794464667,180.160186767578,112,2.25565882339376,0.49778055549625 +-160.11545,55.5657479,13.719616,-385006.263013774,634859.784500307,173.578201293945,112,2.23949518367351,0.439069602470223 +-160.05694,55.5687904,13.719616,-381302.0839663,634859.769274388,168.667526245117,112,2.22703147541595,0.39379785658223 +-159.99843,55.5718037,13.719616,-377598.497082491,634859.805966166,168.702850341797,112,2.2271224203322,0.39412819447632 +-159.9399,55.5747878,13.719616,-373894.24116284,634859.780636532,154.769165039062,112,2.18968443963306,0.258142762713481 +-159.88136,55.5777427,13.719616,-370189.938353939,634859.751047802,142.559051513672,112,2.15399479721645,0.128507794618226 +-159.82282,55.5806684,13.719616,-366486.210800188,634859.772743928,94.1853179931641,12,1.97398320840318,-0.525345676374368 +-159.76427,55.5835649,13.49556559,-362782.425078283,634859.789797084,47.5,12,1.67669360962487,-1.60518635403669 +-159.58855,55.5920792,12.6767129,-351670.034683441,634859.764056953,49.3552703857422,12,1.69333353547032,-1.54474539385831 +-159.52996,55.5948588,13.719616,-347965.960767639,634859.7559681,61.4000358581543,12,1.78816862477299,-1.20027728088162 +-159.47137,55.5976092,13.719616,-344262.428212409,634859.797123904,79.8652725219727,12,1.9023579779296,-0.785508957330548 +-159.41276,55.6003303,13.719616,-340558.176706209,634859.772633984,80.0217895507812,12,1.90320825940663,-0.782420492311482 +-159.35415,55.6030222,13.719616,-336854.45523275,634859.797181232,72.2463455200195,12,1.85881588380741,-0.94366627133333 +-159.29552,55.6056848,13.719616,-333150.003456868,634859.758130075,83.8122711181641,12,1.92330760918817,-0.709413916979332 +-159.23689,55.6083182,13.719616,-329446.070377882,634859.767959679,100.588432312012,120,2.00254803964716,-0.421590056081668 +-159.17825,55.6109223,13.719616,-325742.023419848,634859.765338788,84.5849838256836,12,1.92729327059838,-0.694936857116432 +-159.11961,55.6134971,13.719616,-322038.484673105,634859.799268993,73.3028411865234,12,1.86512080803425,-0.920764986936889 +-159.06095,55.6160426,13.719616,-318334.192877765,634859.77273199,78.5999984741211,12,1.89542253760835,-0.810700456149048 +-159.00229,55.6185589,13.719616,-314630.397064628,634859.79379962,108.219192504883,120,2.0343042890497,-0.306242294115663 +-158.94362,55.6210458,13.719616,-310926.465439542,634859.792308307,132.5341796875,120,2.1223278943892,0.0134845649157069 +-158.88494,55.6235035,13.719616,-307222.390635371,634859.791041327,152.433807373047,120,2.18308129723512,0.234158264799685 +-158.82625,55.6259318,13.719616,-303518.168597772,634859.768349474,155.029357910156,120,2.19041394830625,0.260792546437014 +-158.76756,55.6283309,13.719616,-299814.419777985,634859.792190099,139.598693847656,120,2.14488135483865,0.0954051706666453 +-158.70886,55.6307006,13.719616,-296110.512296005,634859.794676035,95.0314331054688,20,1.97786727861863,-0.511237624727834 +-158.65015,55.633041,13.719616,-292406.43963557,634859.787533097,99.195915222168,20,1.99649378875703,-0.44358082336987 +-158.59143,55.6353521,13.719616,-288702.196087686,634859.771387166,105.814239501953,120,2.02454411496762,-0.34169403221279 +-158.53271,55.6376339,13.719616,-284998.403724386,634859.789791313,129.082321166992,120,2.1108667663147,-0.0281455235824825 +-158.47398,55.6398863,13.719616,-281294.429800543,634859.788250303,133.196762084961,120,2.12449366758409,0.021351271332765 +-158.41524,55.6421094,13.719616,-277590.267832287,634859.778544618,131.940505981445,120,2.12037814523275,0.00640251946568034 +-158.35649,55.6443032,13.719616,-273885.912103806,634859.76135193,132.124893188477,120,2.12098464922618,0.00860551508329911 +-158.29774,55.6464676,13.719616,-270181.985401003,634859.766926853,134.207778930664,120,2.12777768907256,0.0332797747319694 +-158.23899,55.6486026,13.719616,-266478.48197529,634859.794297775,133.19172668457,120,2.12447724910734,0.0212916347389248 +-158.18022,55.6507083,13.719616,-262774.139810021,634859.774490948,130.303039550781,120,2.11495454652406,-0.01329753909347 +-158.12145,55.6527846,13.719616,-259070.209439529,634859.776808156,129.097061157227,120,2.11091635583941,-0.0279654002744952 +-158.06267,55.6548315,13.719616,-255366.057327678,634859.761864455,129.544097900391,120,2.1124176310796,-0.0225123400955071 +-158.00389,55.6568491,13.719616,-251662.304830954,634859.779430656,129.143280029297,120,2.11107181258348,-0.0274007370082573 +-157.9451,55.6588373,13.719616,-247958.319101221,634859.780142143,130.199279785156,120,2.11460858188043,-0.0145541814272912 +-157.8863,55.6607961,13.719616,-244254.094380542,634859.764778701,128.210586547852,120,2.1079238870353,-0.038834901106664 +-157.8275,55.6627256,13.719616,-240550.252050424,634859.781478916,132.287017822266,120,2.12151722616184,0.0105399865262025 +-157.76869,55.6646256,13.719616,-236846.159860756,634859.77146376,135.172225952148,120,2.13088746560822,0.0445753707280684 +-157.70988,55.6664963,13.719616,-233142.438558148,634859.792907427,135.308837890625,120,2.13132616409043,0.046168848832474 +-157.65106,55.6683375,13.719616,-229438.455850235,634859.788170154,130.579254150391,120,2.11587418364894,-0.00995715456533377 +-157.59223,55.6701494,13.719616,-225734.204737448,634859.780348706,119.669486999512,120,2.07798342929508,-0.147587189476599 +-157.5334,55.6719318,13.719616,-222030.308450779,634859.781481376,98.6548767089844,120,1.99411855816859,-0.452208338825394 +-157.47456,55.6736848,13.719616,-218326.132827305,634859.769017461,98.0636520385742,21,1.99150806299405,-0.46169040240881 +-157.41572,55.6754084,13.719616,-214622.299880608,634859.776158729,98.4636459350586,21,1.99327591289278,-0.45526906698205 +-157.35687,55.6771026,13.719616,-210918.176057416,634859.770370114,98.4612884521484,21,1.99326551459738,-0.45530683655889 +-157.29802,55.6787674,13.719616,-207214.383368717,634859.783764159,92.9713821411133,21,1.96834928736205,-0.545809685676894 +-157.23916,55.6804028,13.719616,-203510.288258687,634859.784947535,87.9542770385742,21,1.94425696316912,-0.633319883779563 +-157.1803,55.6820087,13.719616,-199806.513269225,634859.793813242,84.3957824707031,21,1.92632074407273,-0.698469351044284 +-157.12143,55.6835852,13.719616,-196102.424288904,634859.791239055,84.6383666992188,21,1.92756727401577,-0.693941598496089 +-157.06255,55.6851322,13.719616,-192398.016054691,634859.767057045,84.2229690551758,121,1.92543054724277,-0.701702800018161 +-157.00367,55.6866498,13.719616,-188693.910038047,634859.761787207,86.9881820678711,121,1.93946025478718,-0.650742897739662 +-156.94479,55.688138,13.719616,-184990.100459919,634859.774746029,89.5953903198242,121,1.9522856657987,-0.604157344209072 +-156.8859,55.6895967,13.719616,-181285.954241436,634859.766832908,92.0088653564453,121,1.96382967506175,-0.56222620757738 +-156.82701,55.6910259,13.719616,-177582.093354467,634859.765802403,100.504768371582,121,2.00218666701362,-0.422902664632715 +-156.76812,55.6924258,13.719616,-173878.511058339,634859.793276486,172.777648925781,220,2.23748756004084,0.431777340403518 +-156.70921,55.6937961,13.719616,-170173.947397066,634859.763974848,219.543121337891,220,2.34151983446343,0.809652254873737 +-156.65031,55.695137,13.719616,-166470.278986041,634859.778092657,239.635452270508,220,2.37955106908656,0.947792554220051 +-156.5914,55.6964484,13.719616,-162766.244908915,634859.773199734,226.846557617188,220,2.3557321932595,0.861275598632162 +-156.53249,55.6977304,13.719616,-159062.466707473,634859.785463404,232.982788085938,220,2.36732383812727,0.903379761376743 +-156.47357,55.6989829,13.719616,-155358.311226399,634859.779776661,238.462997436523,220,2.3774209986555,0.940055530431819 +-156.41465,55.7002059,13.719616,-151654.400430367,634859.780082613,238.602386474609,220,2.37767478312129,0.940977348048863 +-156.35572,55.7013995,13.719616,-147950.100322379,634859.774687147,246.407379150391,220,2.3916537094839,0.991752798580685 +-156.29679,55.7025636,13.719616,-144246.033280211,634859.775308733,251.174301147461,220,2.39997520257793,1.0219788366888 +-156.23786,55.7036981,13.719616,-140542.193858452,634859.770284172,249.133529663086,220,2.39643218103999,1.00910957118395 +-156.17892,55.7048033,13.719616,-136837.947326321,634859.771907393,245.799438476562,220,2.39058088641533,0.987855998981437 +-156.11998,55.7058789,13.719616,-133133.916770315,634859.767987723,244.106246948242,220,2.38757889363446,0.976951904347263 +-156.06104,55.706925,13.719616,-129430.095991612,634859.769176088,239.525970458984,220,2.37935260842097,0.9470716884363 +-156.0021,55.7079417,13.719616,-125726.478830117,634859.786138082,203.989624023438,121,2.30960807750448,0.693739645076594 +-155.94315,55.7089288,13.719616,-122022.432359751,634859.777763711,130.796813964844,121,2.11659716528535,-0.007331078902408 +-155.88419,55.7098865,13.719616,-118317.950092873,634859.767557078,107.054077148438,22,2.02960321202606,-0.323317947686468 +-155.82524,55.7108147,13.719616,-114614.282104436,634859.780136526,98.4719772338867,22,1.99331265827233,-0.455135597275342 +-155.76628,55.7117134,13.719616,-110910.167001704,634859.78000801,93.7662582397461,22,1.97204658575044,-0.532380042616263 +-155.70732,55.7125825,13.719616,-107206.227026009,634859.77344124,85.0686569213867,22,1.92976957614292,-0.685942208570687 +-155.64836,55.7134222,13.719616,-103502.455765992,634859.782322694,79.2643127441406,22,1.89907769845523,-0.797423868666421 +-155.58939,55.7142324,13.719616,-99798.2199060217,634859.780105557,59.8246955871582,122,1.77688049742081,-1.24127898137707 +-155.53042,55.715013,13.719616,-96094.1416558005,634859.771425572,70.0961685180664,22,1.8456942799219,-0.991327681924113 +-155.47145,55.7157642,13.719616,-92390.2146614421,634859.778210693,89.7793350219727,22,1.95317638434301,-0.600922000219752 +-155.41248,55.7164858,13.719616,-88686.4335955825,634859.777839553,120.391304016113,22,2.08059511853138,-0.138100788720035 +-155.3535,55.717178,13.719616,-84982.1643599938,634859.779471279,138.147476196289,22,2.14034295523851,0.0789204079307105 +-155.29452,55.7178406,13.719616,-81278.0293694124,634859.774422175,157.505340576172,122,2.19729528411571,0.285787522225767 +-155.23554,55.7184737,13.719616,-77574.0225542046,634859.773533546,186.890518188477,122,2.2715872681906,0.55563721342915 +-155.17656,55.7190773,13.719616,-73870.1380812471,634859.776518939,232.114151000977,122,2.3657016183288,0.897487396041047 +-155.11758,55.7196514,13.719616,-70166.3701169363,634859.783105238,277.984283447266,221,2.44402024266241,1.18196299398168 +-155.05859,55.7201959,13.719616,-66462.0852220791,634859.771882645,314.034301757812,320,2.49697708836146,1.37431737294926 +-154.9996,55.720711,13.719616,-62757.9049798275,634859.776012335,397.910675048828,320,2.59978559044725,1.74774719699281 +-154.29166,55.7245886,13.719616,-18310.029947939,634859.776195568,540.649475097656,420,2.7329157856815,2.23131406522448 +-154.23266,55.7247198,13.719616,-14606.0536536196,634859.775275419,456.243743896484,420,2.65919692237442,1.96354611223472 +-154.17366,55.7248215,13.719616,-10902.1004055089,634859.777632415,511.561553955078,420,2.70889789793999,2.14407424155963 +-161.68449,55.4395679,9.751824092,-485014.194072937,631155.769743011,60.2488594055176,12,1.77994882952776,-1.23013392337545 +-161.62632,55.4433924,13.719616,-481310.136205082,631155.764863535,92.0964584350586,12,1.96424292974425,-0.560725148615909 +-161.56814,55.447188,13.719616,-477606.187955428,631155.778894777,61.6170654296875,12,1.78970101079297,-1.19471121747056 +-161.50995,55.4509545,13.61188987,-473902.346361005,631155.789711005,41.1383628845215,12,1.61424700480242,-1.83201024678735 +-160.9274,55.4870254,13.34785856,-436862.219147647,631155.782029032,15.7406902313232,12,1.19702377231037,-3.34748411456518 +-160.86908,55.4904728,13.04066103,-433157.917110478,631155.747277417,33.5494117736816,12,1.5256849100286,-2.15369305314439 +-160.63572,55.5039718,10.15125979,-418342.307693447,631155.780774424,74.7799377441406,12,1.87378509925913,-0.889293808173209 +-160.57735,55.5072739,13.24308061,-414638.148875676,631155.769087759,96.0420608520508,12,1.98246147049235,-0.49455020852956 +-160.40219,55.5170055,13.71328457,-403526.35383854,631155.790606491,83.3114242553711,12,1.92070455904033,-0.718868938100745 +-160.34378,55.5201911,13.71847752,-399822.21213008,631155.772672169,171.366851806641,12,2.23392681834729,0.418843710235678 +-160.28536,55.5233476,13.719616,-396118.060451044,631155.756715257,183.054138183594,12,2.26257955113607,0.522918614028705 +-160.22694,55.526475,13.719616,-392414.521551191,631155.802101143,64.1570434570312,12,1.80724434218568,-1.13098883048692 +-160.1685,55.5295733,13.719616,-388710.333156458,631155.790383948,110.293380737305,12,2.04254944901749,-0.276293519709685 +-160.11005,55.5326424,13.719616,-385006.119035589,631155.770418133,147.868728637695,112,2.16987633886474,0.186194086928097 +-160.0516,55.5356823,13.71958902,-381302.501902228,631155.799930709,54.2534370422363,12,1.73442725664396,-1.39548126923987 +-159.99313,55.5386931,13.719616,-377598.218442229,631155.774952711,62.4180450439453,12,1.79531016227993,-1.17433717825868 +-159.93466,55.5416747,13.719616,-373894.520728829,631155.799000358,186.627380371094,112,2.27097536005224,0.55341458841467 +-159.87617,55.5446272,13.719616,-370190.145462987,631155.770362727,168.860336303711,112,2.22752764988272,0.395600103867849 +-159.81768,55.5475505,13.719616,-366486.344694034,631155.79034847,131.928985595703,12,2.12034022315293,0.00626477564774657 +-159.75918,55.5504446,13.719616,-362782.484443585,631155.803032254,61.3944549560547,12,1.78812914816502,-1.20042067118952 +-159.70066,55.5533095,13.719616,-359077.930731112,631155.754732347,55.1393280029297,12,1.74146146894426,-1.36993100240112 +-159.64214,55.5561452,13.64740028,-355373.934595484,631155.754544595,49.5576858520508,12,1.69511101834265,-1.53828906872187 +-159.58362,55.5589517,12.82822377,-351670.490392458,631155.801208473,62.3432655334473,12,1.7947895468342,-1.17622820215601 +-159.52508,55.561729,13.719616,-347966.335794693,631155.78868451,64.8512496948242,12,1.81191834943069,-1.11401150207855 +-159.46653,55.5644771,13.719616,-344262.093494309,631155.770922133,88.9673843383789,12,1.94923082239801,-0.615253407379469 +-159.40798,55.5671959,13.719616,-340558.387087655,631155.788548045,80.8101577758789,12,1.90746595469466,-0.766955327758112 +-159.34941,55.5698855,13.719616,-336853.953315433,631155.750010174,78.844367980957,12,1.89677067620455,-0.805803631970591 +-159.29084,55.5725459,13.719616,-333150.043204214,631155.757787784,77.1996536254883,12,1.88761535177516,-0.839058383487907 +-159.23226,55.5751771,13.719616,-329446.022757075,631155.761089621,84.8274459838867,12,1.92853639129964,-0.690421487907461 +-159.17368,55.577779,13.719616,-325742.515523239,631155.79835916,84.1046295166016,12,1.92481990207826,-0.703920837551156 +-159.11508,55.5803517,13.719616,-322038.258274705,631155.782560588,83.7441864013672,12,1.92295466763197,-0.710695901451003 +-159.05648,55.5828951,13.719616,-318334.502877754,631155.800653053,81.2695846557617,12,1.90992804021091,-0.758012330413916 +-158.99786,55.5854092,13.719616,-314629.986957857,631155.756748782,84.8458480834961,12,1.92863059505034,-0.690079312996503 +-158.93924,55.5878941,13.719616,-310925.960672741,631155.757819488,107.639694213867,120,2.03197245533643,-0.31471217973384 +-158.88062,55.5903497,13.719616,-307222.419172644,631155.791646107,134.479919433594,120,2.12865744024733,0.0364752821046941 +-158.82198,55.592776,13.719616,-303518.100077465,631155.765725866,152.395614624023,120,2.18297246981204,0.233762972536646 +-158.76334,55.5951731,13.719616,-299814.253568841,631155.783724878,152.795562744141,120,2.18411074230436,0.237897503124043 +-158.70469,55.5975408,13.719616,-296110.247210304,631155.777758945,153.567031860352,120,2.18629799031843,0.245842212213898 +-158.64603,55.5998793,13.719616,-292406.073710266,631155.770670171,119.514068603516,120,2.07741903128622,-0.149637244140003 +-158.58737,55.6021884,13.719616,-288702.35727049,631155.78432993,113.08757019043,120,2.0534148728798,-0.236827198941022 +-158.5287,55.6044683,13.719616,-284998.462294658,631155.79702153,132.474990844727,120,2.12213389817252,0.0127799152846981 +-158.47002,55.6067188,13.719616,-281294.384601327,631155.787167279,136.222534179688,120,2.13424895530364,0.0567852607665097 +-158.41133,55.60894,13.719616,-277590.117710112,631155.766549205,135.272415161133,120,2.131209244013,0.0457441617389114 +-158.35264,55.6111319,13.719616,-273886.284248502,631155.777087968,136.476959228516,120,2.13505933764388,0.0597288007323997 +-158.29394,55.6132945,13.719616,-270182.250161315,631155.777119556,136.99072265625,120,2.1366911566774,0.0656560332296685 +-158.23523,55.6154278,13.719616,-266478.009732265,631155.767349459,135.688186645508,120,2.13254203853668,0.0505852518663813 +-158.17652,55.6175317,13.719616,-262774.186284219,631155.776943805,133.901992797852,120,2.12678704045241,0.0296814561843228 +-158.1178,55.6196063,13.719616,-259070.145037276,631155.777069521,132.556442260742,120,2.12240083935167,0.0137495218399676 +-158.05908,55.6216515,13.719616,-255366.509291503,631155.795801955,132.111572265625,120,2.12094086114959,0.00844646429077415 +-158.00034,55.6236674,13.719616,-251662.015943051,631155.767556132,131.268920898438,120,2.11816191512215,-0.00164746087106775 +-157.9416,55.6256539,13.719616,-247957.916609763,631155.758326785,129.808059692383,120,2.11330165834463,-0.019301300742411 +-157.88286,55.6276111,13.719616,-244254.204885454,631155.778345475,126.05281829834,120,2.10055256010952,-0.0656096644872427 +-157.82411,55.6295389,13.719616,-240550.247343801,631155.77939012,128.979675292969,120,2.11052127926399,-0.0294004311625066 +-157.76535,55.6314373,13.719616,-236846.038226769,631155.762268325,134.454345703125,120,2.12857484363174,0.0361752676214639 +-157.70659,55.6333064,13.719616,-233142.199493826,631155.774031752,125.447319030762,120,2.09846138432271,-0.0732054118259599 +-157.64782,55.6351461,13.719616,-229438.097684828,631155.768168856,111.362419128418,120,2.04673865655808,-0.261077122203389 +-157.58905,55.6369564,13.719616,-225734.355378007,631155.77951688,108.153289794922,120,2.03403973429801,-0.307203232485241 +-157.53027,55.6387374,13.719616,-222030.337877177,631155.78495652,98.2063827514648,21,1.99213971491178,-0.459396062352222 +-157.47148,55.6404889,13.719616,-218326.040611246,631155.763107845,98.9002990722656,21,1.99519760489585,-0.448288933121385 +-157.41269,55.6422111,13.719616,-214622.084980178,631155.769428157,96.5726776123047,21,1.98485427299301,-0.485858866873345 +-157.3539,55.6439039,13.719616,-210918.465808379,631155.792016671,97.5375366210938,21,1.98917178298227,-0.470176438252303 +-157.29509,55.6455672,13.719616,-207213.921198546,631155.756580033,95.6468200683594,21,1.98067053578808,-0.501055394559137 +-157.23629,55.6472012,13.719616,-203510.329286917,631155.779906123,89.5224761962891,21,1.9519320862941,-0.605441645891391 +-157.17748,55.6488058,13.719616,-199806.428183534,631155.788286124,83.1530609130859,21,1.91987824048513,-0.721870362948042 +-157.11866,55.6503809,13.719616,-196102.212638832,631155.771541266,84.2764053344727,21,1.92570600324484,-0.700702265195684 +-157.05984,55.6519267,13.719616,-192398.304163493,631155.781867395,85.6973190307617,21,1.93296723559463,-0.674327396739208 +-157.00101,55.653443,13.719616,-188694.069678277,631155.767894914,85.4033203125,121,1.93147475552935,-0.679748510332502 +-156.94218,55.6549299,13.719616,-184990.131224461,631155.769600596,86.4169387817383,121,1.93659887787725,-0.661136235394822 +-156.88335,55.6563874,13.719616,-181286.483024751,631155.786315465,91.6743698120117,121,1.96224793321561,-0.56797154543664 +-156.82451,55.6578155,13.719616,-177582.490960237,631155.790643801,100.696914672852,121,2.00301616408805,-0.419889694496342 +-156.76566,55.6592141,13.719616,-173878.149715333,631155.772483014,165.43879699707,121,2.21863736341437,0.363308045874409 +-156.70681,55.6605833,13.719616,-170174.081366361,631155.769633475,212.393768310547,121,2.32714177028116,0.757427021855648 +-156.64796,55.6619231,13.719616,-166470.280131723,631155.781478847,247.026504516602,220,2.39274355304818,0.995711421478479 +-156.5891,55.6632334,13.719616,-162766.112322592,631155.771772727,236.576904296875,220,2.37397234457758,0.927529034476937 +-156.53024,55.6645143,13.719616,-159062.200041821,631155.776683101,238.72802734375,220,2.37790340939714,0.941807783939167 +-156.47137,55.6657657,13.719616,-155357.909578875,631155.761104626,243.021011352539,220,2.38564382388629,0.969923178698036 +-156.41251,55.6669877,13.719616,-151654.491394905,631155.78295273,240.435836791992,220,2.38099919944165,0.953052577007303 +-156.35363,55.6681803,13.719616,-147950.054681908,631155.773170004,249.893280029297,220,2.39775457751326,1.01391289262443 +-156.29476,55.6693434,13.719616,-144246.479058957,631155.78859011,254.113571166992,220,2.40502785956257,1.04033152902889 +-156.23588,55.670477,13.719616,-140542.502027142,631155.784689858,252.205703735352,220,2.40175490409582,1.02844322057916 +-156.17699,55.6715812,13.719616,-136838.117402475,631155.773767696,248.643051147461,220,2.39557632646596,1.00600086308587 +-156.1181,55.6726559,13.719616,-133133.948090802,631155.765909083,245.685043334961,220,2.39037871856878,0.987121667658303 +-156.05921,55.6737012,13.719616,-129429.987926218,631155.771766403,243.644134521484,220,2.3867559606563,0.973962776882148 +-156.00032,55.674717,13.719616,-125726.231452676,631155.779730679,213.756546020508,121,2.32991942331625,0.767516250500223 +-155.94142,55.6757033,13.719616,-122022.044507644,631155.77096943,169.17561340332,121,2.22833775983968,0.398542654459909 +-155.88252,55.6766602,13.719616,-118318.049293014,631155.775665039,120.252899169922,121,2.08009555555166,-0.13991534405183 +-155.82362,55.6775876,13.719616,-114614.240320834,631155.782247373,112.25919342041,22,2.05022191749951,-0.248424924242437 +-155.76471,55.6784855,13.719616,-110909.983426358,631155.773596977,110.286056518555,22,2.04252060799923,-0.276398278520043 +-155.7058,55.6793539,13.719616,-107205.90112516,631155.767124287,117.941482543945,122,2.07166658262958,-0.170531779573231 +-155.64689,55.6801929,13.719616,-103501.987315329,631155.77357667,116.1982421875,122,2.06519955822606,-0.194021858079355 +-155.58798,55.6810024,13.719616,-99798.2364666807,631155.781435944,126.02717590332,122,2.10046420442122,-0.0659305975664016 +-155.52906,55.6817824,13.719616,-96094.0144118314,631155.775866779,136.711334228516,122,2.13580452180152,0.0624355222897019 +-155.47014,55.6825329,13.719616,-92389.9436638065,631155.772101829,146.584045410156,122,2.1660867031332,0.172429048281451 +-155.41122,55.6832539,13.719616,-88686.0183945452,631155.769801931,165.611755371094,122,2.21909116041748,0.364956366116273 +-155.3523,55.6839455,13.719616,-84982.2325485406,631155.779782141,186.325500488281,122,2.27027229646076,0.550860860776077 +-155.29337,55.6846075,13.719616,-81277.9524197844,631155.767209799,236.520629882812,122,2.37386902690692,0.927153755207274 +-155.23445,55.6852401,13.719616,-77574.4284157348,631155.779102639,311.48876953125,122,2.49344239315079,1.36147835104164 +-155.17552,55.6858432,13.719616,-73870.3982521029,631155.780114337,372.041412353516,221,2.57059128438621,1.64170514449456 +-155.11659,55.6864168,13.719616,-70166.4844387636,631155.782210954,400.796936035156,221,2.60292439282897,1.75914822314664 +-155.05765,55.6869609,13.719616,-66462.0528041348,631155.77512551,417.631896972656,320,2.62079366085195,1.82405450500298 +-154.99872,55.6874755,13.719616,-62758.3541977284,631155.779185212,509.281585693359,320,2.7069579734934,2.13702788226005 +-154.93978,55.6879606,13.719616,-59054.1261066262,631155.774699759,585.480712890625,420,2.76751259296408,2.35697954418672 +-154.23246,55.691481,13.719616,-14606.4630623188,631155.781961318,368.279052734375,420,2.56617701741427,1.62567126689525 +-154.17351,55.6915825,13.719616,-10902.3609596422,631155.77083164,644.932312011719,420,2.80951413624398,2.50954113781331 +-161.67774,55.4065381,10.21163772,-485014.469822163,627451.811530967,75.9344863891602,12,1.88043905978173,-0.865124724325712 +-161.61962,55.4103594,13.70111098,-481310.398198405,627451.801469447,82.2956237792969,12,1.91537674142083,-0.73822109240532 +-161.56149,55.4141518,13.719616,-477606.434648914,627451.807549126,77.3105850219727,12,1.88823895966111,-0.836793261650704 +-161.50334,55.4179152,10.91709917,-473901.946056718,627451.747357378,30.890941619873,12,1.48983114669841,-2.28392415524252 +-160.9213,55.4539561,13.719616,-436862.166349824,627451.774023603,90.3699569702148,12,1.95602407549078,-0.590578373159055 +-160.86304,55.4574006,13.63112674,-433158.455199976,627451.796824351,58.2499046325684,12,1.76529521866658,-1.28336002058018 +-160.62987,55.4708885,12.19569087,-418342.045877021,627451.762640541,75.4369125366211,12,1.8775839053954,-0.875495459999059 +-160.57156,55.4741878,13.719616,-414638.469643278,627451.803225885,118.952911376953,12,2.07537507587705,-0.157061473589072 +-160.45489,55.4806992,12.92391444,-407230.085614231,627451.76460411,102.692085266113,12,2.01153697273349,-0.38893968541517 +-160.39654,55.4839113,13.719616,-403525.895576694,627451.748863251,148.280334472656,12,2.17108355698705,0.190579047722683 +-160.33819,55.4870943,13.719616,-399822.328678353,627451.792346418,131.191146850586,12,2.11790452860926,-0.00258236215132233 +-160.27982,55.4902481,13.719616,-396118.122588714,627451.763264031,77.443603515625,12,1.88898555285587,-0.834081422068424 +-160.22144,55.4933729,13.719616,-392413.898504427,627451.744837295,51.2000007629395,12,1.70926996744732,-1.48685972420729 +-160.16306,55.4964686,13.719616,-388710.280794882,627451.784799582,93.2800216674805,12,1.96978863829472,-0.540581552257783 +-160.10466,55.4995351,13.719616,-385006.007093469,627451.754742424,76.7475204467773,12,1.88506435322183,-0.848324338361075 +-159.98784,55.5055808,13.719616,-377597.981799573,627451.753248277,62.9772567749023,12,1.79918373928767,-1.16026724093761 +-159.92942,55.50856,13.719616,-373894.219010458,627451.781367481,98.7325744628906,112,1.99446046143873,-0.45096644855932 +-159.87099,55.51151,13.719616,-370190.406675983,627451.798778185,168.737121582031,112,2.22721063638134,0.394448620346174 +-159.81254,55.5144308,13.719616,-366485.910264841,627451.750660406,171.778244018555,112,2.23496815890734,0.422626156377971 +-159.75409,55.5173225,13.719616,-362781.980974239,627451.759416913,159.129089355469,112,2.20174957745791,0.301966787026522 +-159.69563,55.520185,13.719616,-359077.985252158,627451.758598267,132.034057617188,12,2.12068597004983,0.00752062706326599 +-159.63716,55.5230183,13.719616,-355373.91745912,627451.748606936,122.73706817627,12,2.08897574506755,-0.107659961071672 +-159.57869,55.5258225,13.719616,-351670.399917048,627451.793913111,75.8268814086914,12,1.87982319478588,-0.867361721775998 +-159.5202,55.5285975,13.719616,-347966.170140088,627451.777380005,68.1461029052734,12,1.83344102473227,-1.03583500220009 +-159.46171,55.5313432,13.719616,-344262.48119423,627451.793694352,90.2139434814453,12,1.95527366735403,-0.593304069699539 +-159.4032,55.5340598,13.719616,-340558.067795064,627451.761280922,107.524108886719,112,2.03150585199633,-0.316407016246956 +-159.34469,55.5367472,13.719616,-336854.183014306,627451.772621777,100.344604492188,12,2.00149402553036,-0.425418536199447 +-159.28617,55.5394054,13.719616,-333150.192301963,627451.776357448,90.2375564575195,12,1.95538732653971,-0.592891227095588 +-159.22764,55.5420343,13.719616,-329446.09088039,627451.761872792,93.1209487915039,12,1.96904739227161,-0.543273969386386 +-159.16911,55.5446341,13.719616,-325742.500230226,627451.800933536,97.7341613769531,12,1.99004639078474,-0.466999613075805 +-159.11056,55.5472046,13.719616,-322038.158639744,627451.773186165,97.5956954956055,12,1.98943066332518,-0.469236110955036 +-159.05201,55.5497459,13.719616,-318334.317369838,627451.787807927,84.2006607055664,12,1.92531549933404,-0.702120686860612 +-158.99345,55.5522579,13.719616,-314630.342697783,627451.78518211,82.9750595092773,12,1.91894757255448,-0.725250814511252 +-158.93488,55.5547407,13.719616,-310926.228103803,627451.776972054,102.858856201172,120,2.01224169062204,-0.386379948897448 +-158.8763,55.5571943,13.719616,-307221.967922779,627451.763745748,118.582809448242,120,2.07402173537827,-0.161977192562443 +-158.81772,55.5596185,13.719616,-303518.187001063,627451.769563001,148.787033081055,120,2.17256508371838,0.195960375680737 +-158.75913,55.5620136,13.719616,-299814.248319688,627451.781532631,150.776596069336,120,2.17833393445976,0.216914488167361 +-158.70053,55.5643793,13.719616,-296110.148601285,627451.766922941,148.47607421875,120,2.17165647606448,0.192660053339328 +-158.64193,55.5667158,13.719616,-292406.509456751,627451.792606943,157.573196411133,120,2.19748234487476,0.286466980295081 +-158.58331,55.5690231,13.719616,-288702.067415554,627451.770599467,126.927154541016,120,2.10355454412575,-0.0547056016887824 +-158.52469,55.571301,13.719616,-284998.076115418,627451.766816068,133.55143737793,120,2.12564856657637,0.0255461941137147 +-158.46606,55.5735497,13.719616,-281293.899424409,627451.760113197,138.881362915039,120,2.14264396981093,0.0872783496327034 +-158.40743,55.575769,13.719616,-277590.162039381,627451.770726328,140.487274169922,120,2.14763698610523,0.105414409962324 +-158.34879,55.5779591,13.719616,-273886.22786429,627451.778656046,137.286666870117,120,2.13762836108301,0.0690602271356273 +-158.29014,55.5801199,13.719616,-270182.091935943,627451.773480465,138.904968261719,120,2.14271777957535,0.0875464477644664 +-158.23149,55.5822513,13.719616,-266478.378148513,627451.784913533,136.516204833984,120,2.13518420633845,0.0601823594721504 +-158.17283,55.5843535,13.719616,-262774.450459983,627451.794671846,134.352996826172,120,2.12824735808258,0.0349857466332266 +-158.11416,55.5864263,13.719616,-259070.30456271,627451.781249983,135.495635986328,120,2.13192530777443,0.0483451097053825 +-158.05548,55.5884698,13.719616,-255365.934029027,627451.756513181,132.106323242188,120,2.12092360552873,0.00838378695056862 +-157.9968,55.590484,13.719616,-251661.962037412,627451.759115234,129.848083496094,120,2.11343554400603,-0.018814989805422 +-157.93812,55.5924689,13.719616,-247958.382866575,627451.788155065,128.12614440918,120,2.10763775748956,-0.0398742052862721 +-157.87942,55.5944244,13.719616,-244253.933647736,627451.758063486,128.934173583984,120,2.11036804095267,-0.0299570364477929 +-157.82073,55.5963506,13.719616,-240550.49468124,627451.791097609,129.885986328125,120,2.11356229665676,-0.0183545879991911 +-157.76202,55.5982475,13.719616,-236846.173546657,627451.777731095,127.583549499512,120,2.10579468048107,-0.0465687870476904 +-157.70331,55.600115,13.719616,-233142.22293434,627451.779548554,112.407844543457,120,2.05079662015705,-0.246337440153813 +-157.64459,55.6019531,13.719616,-229438.008188011,627451.76116395,100.267692565918,120,2.00116102075152,-0.426628104605248 +-157.58587,55.6037619,13.719616,-225734.151845175,627451.768541874,100.252502441406,21,2.0010952220197,-0.426867104380032 +-157.52714,55.6055414,13.719616,-222030.019276305,627451.767439564,97.3439636230469,21,1.98830902574324,-0.473310218799909 +-157.46841,55.6072915,13.719616,-218326.234228665,627451.780481358,95.1881561279297,21,1.97858291426391,-0.508638231801425 +-157.40967,55.6090122,13.719616,-214622.162040551,627451.77456441,95.8948745727539,21,1.98179539544745,-0.496969583209378 +-157.35093,55.6107035,13.719616,-210918.425845444,627451.782348907,95.9045867919922,21,1.98183937850346,-0.49680982419594 +-157.29218,55.6123655,13.719616,-207214.390426937,627451.783002015,94.9410705566406,21,1.97745412451969,-0.512738318341086 +-157.23342,55.6139981,13.719616,-203510.050589525,627451.766323234,85.2604904174805,21,1.93074782637577,-0.682388924504532 +-157.17466,55.6156013,13.719616,-199806.029462915,627451.763338812,83.5434875488281,21,1.92191260106553,-0.714480984655732 +-157.1159,55.6171752,13.719616,-196102.320754768,627451.784458456,83.9800796508789,21,1.92417628220857,-0.706258648625251 +-157.05713,55.6187196,13.719616,-192398.29085089,627451.777745027,84.6162185668945,21,1.92745361314576,-0.694354447218029 +-156.99835,55.6202347,13.719616,-188693.932943849,627451.766438062,82.9554214477539,21,1.91884477406025,-0.725624207983911 +-156.93958,55.6217203,13.719616,-184990.500072474,627451.784979398,85.9030838012695,21,1.93400875467915,-0.670544302145072 +-156.88079,55.6231766,13.719616,-181286.09877171,627451.771397498,89.6329040527344,121,1.95246746753367,-0.603496988416276 +-156.822,55.6246035,13.719616,-177581.981565424,627451.770733112,98.658561706543,121,1.99413477981186,-0.4521494171869 +-156.76321,55.6260009,13.719616,-173878.143140489,627451.771212162,151.703170776367,121,2.18099465815185,0.226578996063164 +-156.70441,55.627369,13.719616,-170173.947884208,627451.768846867,204.294311523438,121,2.31025627408044,0.696094080054179 +-156.64561,55.6287076,13.719616,-166470.01983321,627451.767496256,237.44612121582,121,2.37556507958944,0.933314302651849 +-156.58681,55.6300168,13.719616,-162766.352744308,627451.777691032,246.622695922852,220,2.39203304087488,0.993130638464679 +-156.528,55.6312966,13.719616,-159062.311938534,627451.774891245,248.843627929688,220,2.39592652436312,1.00727288180478 +-156.46919,55.632547,13.719616,-155358.520532447,627451.783587942,250.150695800781,220,2.3982017152227,1.01553702441092 +-156.41037,55.633768,13.719616,-151654.343845157,627451.780382962,254.071380615234,220,2.40495574753409,1.04006959755862 +-156.35155,55.6349595,13.719616,-147950.405385792,627451.777542775,259.000274658203,220,2.41330022463136,1.07037912012681 +-156.29272,55.6361217,13.719616,-144246.069672841,627451.775081603,256.748840332031,220,2.40950849067813,1.05660646014004 +-156.23389,55.6372544,13.719616,-140541.960598234,627451.773040992,252.865005493164,220,2.40288873059864,1.03256160206371 +-156.17506,55.6383576,13.719616,-136838.072346143,627451.770910183,248.395523071289,220,2.39514376411744,1.00442967317046 +-156.11623,55.6394314,13.719616,-133134.398744889,627451.779328514,247.934371948242,220,2.39433673859791,1.00149832613551 +-156.05739,55.6404758,13.719616,-129430.305108323,627451.778323436,229.935394287109,220,2.36160582799151,0.882610316481055 +-155.99855,55.6414907,13.719616,-125726.414881262,627451.776892136,227.362564086914,121,2.35671895837772,0.864859811192342 +-155.9397,55.6424762,13.719616,-122022.093020973,627451.767340798,187.401336669922,121,2.27277268423746,0.559942982862795 +-155.88085,55.6434323,13.719616,-118317.962635478,627451.768715055,173.303695678711,121,2.23880782408586,0.43657291625591 +-155.822,55.6443589,13.719616,-114614.018239466,627451.769446076,124.878646850586,122,2.09648818418867,-0.0803726379201754 +-155.76315,55.6452561,13.719616,-110910.253715864,627451.780254453,129.844497680664,122,2.11342355059562,-0.0188585532953224 +-155.70429,55.6461238,13.719616,-107206.034659982,627451.773454475,137.086853027344,122,2.13699580685768,0.066762609640263 +-155.64543,55.646962,13.719616,-103501.984147419,627451.765912889,144.908767700195,122,2.16109466323941,0.15429653451714 +-155.58657,55.6477708,13.719616,-99798.0960887093,627451.768390863,154.772064208984,122,2.18969257485629,0.25817231216627 +-155.52771,55.6485502,13.719616,-96094.3646895599,627451.780524131,169.172393798828,122,2.22832949464269,0.398512632905328 +-155.46884,55.6493001,13.719616,-92390.1555032481,627451.776909888,190.325881958008,122,2.27949785096296,0.584370707963505 +-155.40997,55.6500205,13.719616,-88686.0916029291,627451.772237014,230.293884277344,221,2.36228240492094,0.885067837003056 +-155.3511,55.6507115,13.719616,-84982.1669362724,627451.777320679,312.242004394531,221,2.49449132617574,1.36528837518354 +-155.29223,55.651373,13.719616,-81278.3759235129,627451.780709041,411.520904541016,221,2.6143919015075,1.80080148781988 +-155.23335,55.652005,13.719616,-77574.0838397055,627451.770422561,494.841827392578,221,2.69446640202829,2.09165492924933 +-155.17447,55.6526076,13.719616,-73869.9135588556,627451.770113254,541.664245605469,320,2.73373016944594,2.23427213950517 +-155.1156,55.6531807,13.719616,-70166.4883683489,627451.778933927,536.328002929688,320,2.72943047307783,2.21865441504066 +-155.05671,55.6537244,13.719616,-66461.9155680523,627451.776070813,530.859741210938,320,2.72497979101662,2.20248826744325 +-154.99783,55.6542385,13.719616,-62758.0763886311,627451.770692338,524.011779785156,320,2.7193410500337,2.18200675073637 +-154.93895,55.6547232,13.719616,-59054.3357582079,627451.774283654,530.592712402344,420,2.72476128072889,2.20169457570915 +-154.88006,55.6551785,13.719616,-55350.0589788604,627451.778291849,672.369873046875,420,2.8276082457213,2.57526410800796 +-154.23225,55.6582406,13.719616,-14606.2213077768,627451.773720223,543.698486328125,420,2.73535812391534,2.24018533480252 +-161.67099,55.3735062,13.719616,-485014.004917149,623747.747463174,119.609802246094,12,2.07776677235262,-0.148374149331655 +-161.61292,55.3773244,13.70689085,-481309.923680664,623747.743853679,26.0788383483887,12,1.41628824234667,-2.55105297508282 +-161.55484,55.3811136,13.719616,-477605.950259152,623747.742547939,85.3200988769531,12,1.93105135007896,-0.681286439780258 +-161.03161,55.4139145,11.57938362,-444270.319326712,623747.782808669,11.5569009780884,12,1.06284139216828,-3.83487281870557 +-160.97342,55.4174142,13.719616,-440566.486054864,623747.799758995,23.9607524871826,12,1.37950045294513,-2.68467672646968 +-160.91521,55.420885,13.719616,-436862.069422004,623747.76626352,152.160980224609,12,2.18230329733761,0.231332347108643 +-160.857,55.4243267,13.719616,-433158.325135432,623747.792435257,78.3387069702148,12,1.89397639896657,-0.815953244465073 +-160.79877,55.4277394,13.719616,-429453.987583218,623747.758507632,81.9777526855469,12,1.91369600852008,-0.744325994029789 +-160.74054,55.431123,13.719616,-425750.311271065,623747.783461906,41.6777038574219,12,1.61990378443926,-1.81146320854072 +-160.68229,55.4344777,13.719616,-422046.029482549,623747.760872311,50.6976585388184,12,1.70498790199305,-1.50241340816039 +-160.62404,55.4378033,13.719616,-418342.397837423,623747.796430887,70.8238143920898,12,1.85017931305788,-0.975036761418334 +-160.56577,55.4410999,13.719616,-414638.150752787,623747.77488662,128.440322875977,12,2.10870138863441,-0.0360107933776313 +-160.50749,55.4443674,13.719616,-410933.913229759,623747.748926939,143.336074829102,12,2.15635550740712,0.137082567844522 +-160.44921,55.4476059,13.719616,-407230.308068048,623747.791190742,137.593185424805,12,2.1385969251372,0.0725783282361624 +-160.39091,55.4508153,13.719616,-403526.07187662,623747.767640653,134.028182983398,12,2.12719612991123,0.0311673858645031 +-160.33261,55.4539956,12.0504109,-399822.457986519,623747.800615367,63.8735046386719,12,1.80532074586645,-1.13797588136743 +-160.21596,55.460269,11.16075935,-392413.926453892,623747.746184825,18.2967681884766,12,1.26237438580359,-3.11011203343566 +-160.15763,55.4633621,13.30303352,-388710.256569387,623747.778651046,54.2967643737793,12,1.73477395009563,-1.39422197966726 +-160.09928,55.4664261,13.719616,-385005.927746909,623747.749504578,54.2321395874023,12,1.73425673872777,-1.39610063898214 +-160.04093,55.469461,13.719616,-381302.193306067,623747.775569148,93.668083190918,12,1.97159163298628,-0.534032560912122 +-159.98257,55.4724668,13.719616,-377598.418196275,623747.798645998,70.4617080688477,12,1.84795316674593,-0.983122760228728 +-159.92419,55.4754434,13.719616,-373893.968357173,623747.751684124,96.8266754150391,12,1.98599502042405,-0.481715346602067 +-159.86581,55.478391,13.719616,-370190.095107147,623747.77038893,160.521331787109,112,2.20553275426012,0.315708364998309 +-159.80742,55.4813094,13.719616,-366486.16536415,623747.776080247,161.542343139648,112,2.20828637794632,0.32571031218906 +-159.74902,55.4841986,13.719616,-362782.173495618,623747.769137756,156.692565917969,112,2.195048392401,0.277626170191207 +-159.69061,55.4870588,13.719616,-359078.111960037,623747.772152352,164.287963867188,112,2.21560574713842,0.352296350250708 +-159.63219,55.4898897,13.719616,-355373.978010093,623747.752233788,158.681579589844,112,2.20052651499179,0.297524275052814 +-159.57377,55.4926916,13.719616,-351670.392631928,623747.796053683,161.773803710938,112,2.20890819697417,0.327968936383039 +-159.51533,55.4954642,13.719616,-347966.094103544,623747.764276918,164.978851318359,112,2.21742827545991,0.358916293315755 +-159.45689,55.4982077,13.719616,-344262.333835878,623747.784898717,136.331039428711,112,2.13459474591481,0.0580412709647625 +-159.39844,55.500922,13.719616,-340558.47766178,623747.794320047,102.797370910645,112,2.01198200752307,-0.387323192033858 +-159.33998,55.5036072,13.719616,-336854.519039373,623747.804113592,108.319076538086,112,2.03470494882885,-0.304786983438075 +-159.28151,55.5062631,13.719616,-333150.454119001,623747.792552296,115.125053405762,112,2.06116984467133,-0.20865892790488 +-159.22303,55.5088899,13.719616,-329446.27546979,623747.782339504,117.925720214844,112,2.07160853731865,-0.170742616710304 +-159.16454,55.5114875,13.719616,-325741.97833359,623747.762877176,113.125007629395,112,2.05355862150302,-0.236305062911573 +-159.10605,55.5140558,13.719616,-322038.187367198,623747.772068399,106.526817321777,112,2.02745895189467,-0.33110651251647 +-159.04755,55.516595,13.719616,-318334.265736637,623747.78305244,111.31330871582,12,2.0465470920643,-0.261772939122753 +-158.98904,55.5191049,13.719616,-314630.209484848,623747.774157774,92.5140914916992,12,1.96620788831723,-0.553587858223831 +-158.93052,55.5215856,13.719616,-310926.012095574,623747.757049481,88.4042663574219,12,1.946473224411,-0.625269790365146 +-158.872,55.5240371,13.719616,-307222.297362405,623747.77855837,115.865287780762,120,2.06395334464986,-0.198548461492859 +-158.81347,55.5264594,13.719616,-303518.430165137,623747.791891219,143.235214233398,120,2.15604980196044,0.135972158405166 +-158.75493,55.5288524,13.719616,-299814.405634741,623747.786531452,152.837799072266,120,2.18423077504063,0.238333496282934 +-158.69638,55.5312162,13.719616,-296110.217286851,623747.774198368,153.685821533203,120,2.18663380299797,0.247061979716464 +-158.63783,55.5335508,13.719616,-292406.48890789,623747.799543041,149.115325927734,120,2.17352228211018,0.199437193451363 +-158.57926,55.5358561,13.719616,-288701.956682198,623747.763467915,140.180679321289,120,2.1466881602614,0.101968003675662 +-158.5207,55.5381321,13.719616,-284998.503275314,623747.797033854,140.625259399414,120,2.14806333656214,0.106963036514364 +-158.46212,55.5403789,13.719616,-281294.233867183,623747.781598375,142.338165283203,120,2.15332136353871,0.126061691283565 +-158.40354,55.5425964,13.719616,-277590.402431577,623747.791988419,141.772598266602,120,2.15159229874839,0.119781234440923 +-158.34495,55.5447846,13.719616,-273886.373805063,623747.785973151,140.182647705078,120,2.1466942584785,0.101990154140782 +-158.28635,55.5469436,13.719616,-270182.141559971,623747.775366827,141.757827758789,120,2.1515470496361,0.119616876749671 +-158.22775,55.5490732,13.719616,-266478.330888538,623747.7787692,135.012832641602,120,2.13037504909182,0.0427141276822828 +-158.16914,55.5511736,13.719616,-262774.305195134,623747.777897785,132.121353149414,120,2.12097301296302,0.00856324885418453 +-158.11052,55.5532447,13.719616,-259070.059484458,623747.762369793,132.774932861328,120,2.12311609048687,0.0163475181160123 +-158.0519,55.5552865,13.719616,-255366.217497062,623747.771385606,129.396499633789,120,2.11192252818514,-0.024310695124613 +-157.99327,55.5572991,13.719616,-251662.143390487,623747.777259433,127.442161560059,120,2.10531312897045,-0.048317919582733 +-157.93464,55.5592823,13.719616,-247958.462251087,623747.795860483,126.892791748047,120,2.10343695233142,-0.0551327286498251 +-157.87599,55.5612362,13.719616,-244253.908767605,623747.763864553,125.430465698242,120,2.09840303472165,-0.0734173542316159 +-157.81735,55.5631607,13.719616,-240550.366226618,623747.78128597,126.021133422852,120,2.10044338130257,-0.0660062330768427 +-157.75869,55.565056,13.719616,-236845.939247358,623747.760845365,109.669822692871,120,2.04008714133101,-0.28523732403956 +-157.70004,55.5669219,13.719616,-233142.511743771,623747.788113054,100.851181030273,120,2.003680988438,-0.417474862697553 +-157.64137,55.5687586,13.719616,-229438.188371553,623747.779184366,99.9226531982422,120,1.99966395713207,-0.43206586697557 +-157.5827,55.5705659,13.719616,-225734.223546582,623747.782316426,97.1095886230469,21,1.98726211436197,-0.477112899754918 +-157.52402,55.5723438,13.719616,-222029.982054949,623747.763266345,94.0391082763672,21,1.97330850228522,-0.527796401575104 +-157.46534,55.5740924,13.719616,-218326.087012257,623747.76691153,95.8655700683594,21,1.98166265916103,-0.497451719288385 +-157.40665,55.5758117,13.719616,-214621.903231423,623747.760152311,91.7008438110352,21,1.9623733319709,-0.567516061365059 +-157.34796,55.5775016,13.719616,-210918.054997467,623747.764524559,87.7631530761719,21,1.94331221779117,-0.636751468649465 +-157.28926,55.5791622,13.719616,-207213.906539629,623747.759196484,86.1790466308594,21,1.9354016853285,-0.665484780444638 +-157.23056,55.5807934,13.719616,-203510.082120735,623747.764613515,78.6063919067383,21,1.89545786228569,-0.810572146838301 +-157.17185,55.5823953,13.719616,-199805.945987206,623747.761086482,79.2066192626953,21,1.89876147690692,-0.798572475588491 +-157.11314,55.5839678,13.719616,-196102.122379752,623747.767970441,84.8348617553711,21,1.92857435646326,-0.690283587596855 +-157.05442,55.585511,13.719616,-192397.975562067,623747.766718834,80.7338714599609,21,1.90705577886003,-0.768445203465328 +-156.9957,55.5870248,13.719616,-188694.129752832,623747.775596398,84.6724548339844,21,1.92774215107198,-0.693306395113053 +-156.93697,55.5885092,13.719616,-184989.949725675,623747.766068338,86.1339721679688,21,1.93517447567144,-0.666310070771194 +-156.87824,55.5899642,13.719616,-181286.059165068,623747.766439062,87.0333786010742,21,1.93968584298829,-0.649923497003957 +-156.81951,55.5913899,13.719616,-177582.45182551,623747.787187049,94.7647552490234,21,1.976646845282,-0.51567058695283 +-156.76077,55.5927862,13.719616,-173878.492969888,623747.790359184,134.782470703125,21,2.12963341317902,0.0400202943630115 +-156.70202,55.5941531,13.719616,-170174.176823445,623747.777001624,192.579208374023,121,2.28460939714026,0.602937302659966 +-156.64327,55.5954906,13.719616,-166470.127066368,623747.773240339,231.291488647461,121,2.36415965135491,0.891886531870702 +-156.58452,55.5967987,13.719616,-162766.337921838,623747.778474566,248.268615722656,220,2.39492182273646,1.00362351872636 +-156.52576,55.5980775,13.719616,-159062.173732415,623747.779299292,257.498565673828,220,2.4107748142639,1.06120610884831 +-156.467,55.5993268,13.719616,-155358.259032444,623747.777939491,258.278839111328,220,2.41208882571012,1.06597897347716 +-156.40823,55.6005467,13.719616,-151653.958152707,623747.762131518,263.636566162109,220,2.4210056463661,1.09836741121371 +-156.34947,55.6017373,13.719616,-147950.523830415,623747.788691279,259.659698486328,220,2.41440454846173,1.07439033948409 +-156.29069,55.6028984,13.719616,-144246.062714081,623747.767980363,253.606430053711,220,2.40416026065072,1.03718016214365 +-156.23192,55.6040302,13.719616,-140542.456610873,623747.788581016,247.983901977539,220,2.3944234892567,1.00181342928932 +-156.17314,55.6051325,13.719616,-136838.441584124,623747.784830893,254.07861328125,220,2.40496811044653,1.04011450318532 +-156.11435,55.6062054,13.719616,-133134.011465435,623747.769042999,233.588912963867,220,2.36845222562837,0.90747838685458 +-156.05557,55.6072489,13.719616,-129430.419381794,623747.781386727,210.072830200195,220,2.32236988649851,0.740094177925824 +-155.99678,55.608263,13.719616,-125726.400635454,623747.781856684,209.625625610352,121,2.32144437173206,0.736732444125865 +-155.93798,55.6092477,13.719616,-122021.949439864,623747.771670095,189.782348632812,122,2.27825581690132,0.579859285739803 +-155.87919,55.6102029,13.719616,-118318.319234922,623747.776551891,191.699630737305,122,2.28262127631622,0.59571588036088 +-155.82039,55.6111288,13.719616,-114614.244680294,623747.782157548,181.190353393555,122,2.25813507204129,0.506774997375816 +-155.76159,55.6120252,13.719616,-110910.350063827,623747.784169009,137.109848022461,122,2.13706864945189,0.067027194733781 +-155.70278,55.6128921,13.719616,-107206.000110521,623747.766039413,144.294631958008,122,2.15925017479148,0.147596826004863 +-155.64398,55.6137297,13.719616,-103502.447361083,623747.782498781,163.268127441406,122,2.21290141175852,0.342473432256768 +-155.58517,55.6145378,13.719616,-99798.427674243,623747.779165318,181.574020385742,122,2.2590537097674,0.510111751802376 +-155.52635,55.6153165,13.719616,-96093.9349729877,623747.768487138,224.864059448242,221,2.35192004667337,0.847428794136359 +-155.46754,55.6160658,13.719616,-92390.222377326,623747.779610864,286.139770507812,221,2.45657822450119,1.22757716842502 +-155.40872,55.6167856,13.719616,-88686.0254190839,623747.772678266,393.320861816406,320,2.59474698208599,1.72944553326272 +-155.3499,55.617476,13.719616,-84981.9675050993,623747.772974265,516.420959472656,320,2.71300386023768,2.15898826858315 +-155.29108,55.6181369,13.719616,-81278.0430583461,623747.769048125,614.021728515625,420,2.78818373988297,2.43206304992888 +-155.23226,55.6187684,13.719616,-77574.2460483592,623747.771742091,684.39501953125,420,2.83530684043954,2.60322760142232 +-155.17343,55.6193705,13.719616,-73869.9412245362,623747.769648802,665.257385253906,420,2.82298970450447,2.55848824804555 +-155.11461,55.6199431,13.719616,-70166.3818907582,623747.774160736,626.767211914062,420,2.7971062691347,2.46447222291456 +-155.05578,55.6204863,13.719616,-66462.3031327934,623747.77447185,567.493774414062,420,2.75396110154366,2.30775665936703 +-154.99695,55.6210001,13.719616,-62758.328610678,623747.781460842,468.927642822266,320,2.67110583472503,2.00680268103414 +-154.93812,55.6214844,13.719616,-59054.452685453,623747.78375534,462.268981933594,420,2.66489475342723,1.98424226094141 +-154.87928,55.6219392,13.719616,-55350.0400748002,623747.772802419,553.750244140625,420,2.74331393070544,2.2690830958775 +-161.72227,55.3366286,13.71741733,-488718.250012937,620043.777115323,68.0833358764648,12,1.83304082670709,-1.03728863565543 +-161.66426,55.3404725,13.719616,-485014.055410615,620043.757763126,118.016700744629,12,2.07194346940796,-0.169526047762785 +-161.60624,55.3442875,13.719616,-481309.971283826,620043.748995577,33.3850860595703,12,1.5235525000887,-2.1614385746965 +-161.54821,55.3480736,13.719616,-477605.992165551,620043.750821288,78.7325668334961,12,1.89615441051037,-0.808042084871595 +-161.49017,55.3518308,10.4207715,-473902.112586046,620043.763260988,21,12,1.32221929473392,-2.8927382427631 +-161.43212,55.3555591,10.64150263,-470198.327072868,620043.786347548,23,12,1.36172783601759,-2.74923194396041 +-161.37405,55.3592585,13.719616,-466494.000137176,620043.749882519,24,12,1.38021124171161,-2.68209493879053 +-161.14168,55.3737669,13.25175685,-451678.101116105,620043.769285359,19.2606620788574,12,1.28467121177358,-3.02912359736493 +-161.08356,55.3773216,13.719616,-447974.137269491,620043.770247251,19.3771686553955,12,1.28729031930043,-3.0196102512597 +-161.02543,55.3808474,13.719616,-444270.229069451,620043.783537626,24.1656608581543,12,1.38319867628538,-2.67124372371985 +-160.96729,55.3843442,13.719616,-440566.372189073,620043.798209509,59.3975563049316,12,1.77376857789172,-1.25258236133698 +-160.90913,55.387812,13.719616,-436861.931089702,620043.748620704,85.6478805541992,12,1.93271662036627,-0.675237702781295 +-160.85097,55.3912508,13.719616,-433158.160271325,620043.767043681,55.5476036071777,12,1.74466532767602,-1.35829367301504 +-160.7928,55.3946607,11.10343218,-429454.423052946,620043.798383647,21.6020908355713,12,1.33449578792898,-2.84814651541862 +-160.61821,55.4047163,13.719616,-418342.105682524,620043.768189872,48.7460098266602,12,1.68793907170253,-1.56433962599619 +-160.56,55.4080101,13.71580042,-414638.453231238,620043.79879988,81.154296875,12,1.90931151935262,-0.760251710143799 +-160.50177,55.4112749,13.719616,-410934.177817103,620043.770373761,68.1886825561523,12,1.83371229971109,-1.03484965404742 +-160.44353,55.4145107,13.719616,-407229.903909352,620043.746142426,91.5613098144531,12,1.96171199677141,-0.569918219573468 +-160.38529,55.4177174,13.68308106,-403526.257044209,620043.776030556,40.9610824584961,12,1.61237142500733,-1.83882288794692 +-160.09392,55.4333153,13.719616,-385006.513614798,620043.802520709,64.943359375,12,1.81253474995506,-1.11177255943581 +-160.03561,55.4363477,13.719616,-381302.098737938,620043.768744127,122.429412841797,112,2.08788576666863,-0.11161907372736 +-159.9773,55.439351,13.719616,-377598.271865563,620043.787269608,146.138320922852,112,2.16476411314927,0.167625023955046 +-159.91898,55.4423251,13.719616,-373894.398381277,620043.789375943,138.13459777832,112,2.1403024674444,0.0787733447061415 +-159.86065,55.4452702,13.719616,-370190.47069596,620043.797612504,128.110916137695,112,2.10758613689832,-0.0400617060076643 +-159.80231,55.4481862,13.719616,-366486.484212334,620043.801257298,155.402755737305,112,2.191458715822,0.264587440260556 +-159.74396,55.4510731,13.719616,-362782.433329731,620043.800695203,150.056396484375,112,2.17625451291421,0.20936143558791 +-159.6856,55.4539308,13.719616,-359078.313397891,620043.785224846,150.451614379883,112,2.17739685217921,0.213510737854482 +-159.62723,55.4567594,13.719616,-355374.117839896,620043.766353356,150.375122070312,112,2.17717599289614,0.212708513898856 +-159.56886,55.4595589,13.719616,-351670.471062494,620043.797456951,149.661437988281,112,2.17510991372796,0.205203924642307 +-159.51047,55.4623293,13.719616,-347966.107429214,620043.772505973,148.978469848633,112,2.17312350934143,0.19798873693418 +-159.45208,55.4650705,13.719616,-344262.282269935,620043.786195375,148.159469604492,112,2.17072941461152,0.189292701532474 +-159.39368,55.4677825,13.719616,-340558.359928571,620043.786029538,123.48006439209,112,2.09159684728497,-0.098139369680963 +-159.33527,55.4704654,13.719616,-336854.333866768,620043.783583026,122.815330505371,112,2.08925258128665,-0.106654412906988 +-159.27685,55.4731192,13.719616,-333150.198467452,620043.779341595,135.178985595703,112,2.13090918310584,0.0446542548781984 +-159.21842,55.4757437,13.719616,-329445.949860511,620043.751592469,137.343215942383,112,2.13780721234375,0.0697098659638628 +-159.15999,55.4783391,13.719616,-325742.210650733,620043.772104063,135.783706665039,112,2.13284766000342,0.0516953562666205 +-159.10155,55.4809054,13.719616,-322038.345201518,620043.791235298,129.678253173828,112,2.11286715173191,-0.0208795527803577 +-159.0431,55.4834424,13.719616,-318334.34957838,620043.78730661,121.501457214355,112,2.08458148662864,-0.123621161968038 +-158.98464,55.4859502,13.719616,-314630.217260661,620043.771971211,114.769500732422,12,2.05982649238747,-0.213538366830782 +-158.92617,55.4884289,13.719616,-310925.941764944,620043.756898224,92.8111801147461,12,1.96760029485769,-0.548530240236495 +-158.8677,55.4908783,13.719616,-307222.14910624,620043.766702284,100.01237487793,120,2.00005374008692,-0.430650064028414 +-158.80922,55.4932986,13.719616,-303518.201967944,620043.77681212,145.249755859375,120,2.16211541108636,0.158004182047705 +-158.75073,55.4956896,13.719616,-299814.096308608,620043.765604174,159.543823242188,120,2.20287999509324,0.306072786531354 +-158.69224,55.4980514,13.719616,-296110.455661086,620043.789386835,162.501892089844,120,2.21085842204963,0.335052710506747 +-158.63373,55.500384,13.719616,-292406.014331117,620043.759050749,159.020980834961,120,2.20145442784073,0.300894719372857 +-158.57522,55.5026874,13.719616,-288702.026677596,620043.76384934,153.147186279297,120,2.1851090220724,0.241523540178971 +-158.51671,55.5049615,13.719616,-284998.487787352,620043.791643662,141.61784362793,120,2.15111797723031,0.118058363302404 +-158.45818,55.5072064,13.719616,-281294.131184316,620043.767822479,143.725860595703,120,2.15753491777615,0.141366522942078 +-158.39965,55.5094221,13.719616,-277590.211222302,620043.778331223,142.361831665039,120,2.15339356711561,0.12632395528382 +-158.34111,55.5116085,13.719616,-273886.092940016,620043.769826312,139.193328857422,120,2.1436184212671,0.0908178354576187 +-158.28257,55.5137656,13.719616,-270182.40064489,620043.783689309,139.67268371582,120,2.14511147790026,0.096241043310069 +-158.22402,55.5158935,13.719616,-266478.497907175,620043.789950636,133.783813476562,120,2.1264035712565,0.0282885866117402 +-158.16546,55.5179922,13.719616,-262774.379046768,620043.789336278,130.026245117188,120,2.11403102122353,-0.0166520465853737 +-158.10689,55.5200615,13.719616,-259070.039759015,620043.760346363,128.449569702148,120,2.10873265374604,-0.0358972295682613 +-158.04832,55.5221016,13.719616,-255366.102958197,620043.764421157,130.830047607422,120,2.11670749942746,-0.00693031380574792 +-157.98974,55.5241125,13.719616,-251661.93294586,620043.762757463,125.328796386719,120,2.0980508688792,-0.0746965210895586 +-157.93116,55.526094,13.719616,-247958.155367655,620043.771227155,123.566329956055,120,2.09190014788589,-0.0970376953277988 +-157.87257,55.5280463,13.719616,-244254.133164738,620043.774408343,120.290687561035,120,2.08023200724508,-0.139419712554135 +-157.81398,55.5299692,13.719616,-240550.49194058,620043.78708085,109.834457397461,120,2.04073860887516,-0.282871007971857 +-157.75537,55.5318629,13.719616,-236845.964658945,620043.759302863,100.454605102539,120,2.00196985073861,-0.423690203229062 +-157.69677,55.5337273,13.719616,-233142.436288798,620043.787770987,100.941345214844,120,2.00406908814772,-0.41606517377715 +-157.63815,55.5355624,13.719616,-229438.011066101,620043.766334543,94.0726699829102,21,1.97346347040305,-0.52723351313883 +-157.57953,55.5373682,13.719616,-225733.943294043,620043.765501017,94.8935012817383,21,1.97723647107722,-0.513528897768631 +-157.52091,55.5391446,13.719616,-222030.227837391,620043.773338192,92.55322265625,21,1.96639154526569,-0.55292076376611 +-157.46228,55.5408918,13.719616,-218326.227764896,620043.778427235,94.7816696166992,21,1.9767243547003,-0.515389050622178 +-157.40364,55.5426096,13.719616,-214621.938519238,620043.759409306,88.2651138305664,21,1.94578908563167,-0.627754777684324 +-157.345,55.5442981,13.719616,-210917.983794199,620043.76007449,84.437141418457,21,1.92653352203964,-0.697696480735594 +-157.28636,55.5459573,13.719616,-207214.357858949,620043.77966789,82.9824447631836,21,1.91898622552212,-0.725110415900131 +-157.22771,55.5475872,13.719616,-203510.424967693,620043.786803561,81.448616027832,21,1.91088370918987,-0.754541067907269 +-157.16905,55.5491877,13.719616,-199806.179918565,620043.771297395,83.2881240844727,21,1.92058308049114,-0.719310182864858 +-157.11039,55.5507589,13.719616,-196102.24643968,620043.774762726,85.4205322265625,21,1.93156227304186,-0.679430621747087 +-157.05172,55.5523008,13.719616,-192397.988781623,620043.767525918,84.5638656616211,21,1.92718482762409,-0.695330752951754 +-156.99305,55.5538133,13.719616,-188694.031723206,620043.767853571,84.2502746582031,21,1.92557132535759,-0.701191453723066 +-156.93438,55.5552965,13.719616,-184990.369004815,620043.786197868,84.7458572387695,21,1.92811847711326,-0.691939471516979 +-156.8757,55.5567503,13.719616,-181286.365355892,620043.783466722,87.5228652954102,21,1.94212152701514,-0.641076397405005 +-156.81701,55.5581748,13.719616,-177582.014534268,620043.771812593,88.3671951293945,21,1.94629107023441,-0.625931426326491 +-156.75832,55.5595699,13.719616,-173877.941274976,620043.76732157,125.275199890137,21,2.09786510437891,-0.0753712707770865 +-156.69963,55.5609356,13.719616,-170174.139806165,620043.769367815,180.157958984375,121,2.25565345306221,0.497761048919236 +-156.64093,55.562272,13.719616,-166469.973898273,620043.763404548,218.900024414062,121,2.34024581000508,0.805024634398245 +-156.58223,55.5635791,13.719616,-162766.067820635,620043.775015498,242.485733032227,121,2.38468619140158,0.966444784178026 +-156.52353,55.5648567,13.719616,-159062.416674369,620043.781348765,251.206649780273,220,2.4000311315805,1.02218198678985 +-156.46482,55.566105,13.719616,-155358.383813536,620043.780703786,256.354034423828,220,2.40884015662806,1.05417888010867 +-156.4061,55.5673239,13.719616,-151653.963894404,620043.763060615,256.661437988281,220,2.40936062314386,1.05606936304997 +-156.34739,55.5685135,13.719616,-147950.410772943,620043.785235695,252.894424438477,220,2.40293925456269,1.0327451195221 +-156.28867,55.5696736,13.719616,-144246.459440348,620043.779312902,244.865707397461,220,2.38892796793048,0.981852127254568 +-156.22994,55.5708044,13.719616,-140542.103339471,620043.76871385,228.373199462891,220,2.358645136315,0.871856239246432 +-156.17121,55.5719058,13.719616,-136837.967097365,620043.764074348,215.303619384766,220,2.33305133063918,0.778892231832449 +-156.11248,55.5729779,13.719616,-133134.044578447,620043.77603568,200.653823852539,220,2.30244744048268,0.667730167564126 +-156.05375,55.5740205,13.719616,-129430.330719189,620043.781845105,202.249114990234,220,2.30588662988531,0.680222285116838 +-155.99501,55.5750337,13.719616,-125726.189358829,620043.773238378,195.096206665039,122,2.29024882531222,0.623421315433573 +-155.93627,55.5760176,13.719616,-122022.244402667,620043.780944214,194.130905151367,122,2.28809467948046,0.615596842918187 +-155.87753,55.576972,13.719616,-118318.490725766,620043.782247443,206.330520629883,122,2.31456347402624,0.711739059654585 +-155.81878,55.5778971,13.719616,-114614.291889559,620043.78173487,200.278289794922,122,2.30163387423976,0.66477506275489 +-155.76003,55.5787927,13.719616,-110910.272741988,620043.775090282,189.536315917969,122,2.27769243484083,0.577812921290853 +-155.70128,55.579659,13.719616,-107206.426896224,620043.7841863,152.024871826172,122,2.18191464592645,0.229920654251158 +-155.64252,55.5804958,13.719616,-103502.119132006,620043.770773055,174.569458007812,122,2.24196826354519,0.448052534451424 +-155.58376,55.5813033,13.719616,-99797.9731143363,620043.773451201,243.91650390625,122,2.38724118659058,0.975725255972699 +-155.525,55.5820813,13.719616,-96093.9835959988,620043.769581282,336.181640625,221,2.52657399228915,1.48182177581205 +-155.46624,55.5828299,13.719616,-92390.14451244,620043.769951855,470.721282958984,320,2.67276383472616,2.01282501027854 +-155.40748,55.5835492,13.719616,-88686.4498379553,620043.785365618,603.24267578125,420,2.78049205766396,2.40412466468475 +-155.11362,55.5867041,13.719616,-70166.1648043197,620043.77991631,648.549682617188,420,2.81194325113716,2.51836437644377 +-155.05484,55.5872468,13.719616,-66461.9567756492,620043.773479958,544.076721191406,420,2.735660144626,2.24128236022893 +-154.99607,55.5877601,13.719616,-62758.482844753,620043.780642804,412.405426025391,420,2.61532437066915,1.8041884819682 +-154.93729,55.588244,13.719616,-59054.4771907891,620043.781716415,384.425689697266,420,2.58481240220403,1.69336030352002 +-154.8785,55.5886984,13.719616,-55349.9341673636,620043.767015687,599.129211425781,420,2.77752049477272,2.39333110009528 +-162.64115,55.2382277,13.719616,-547982.23767194,616339.784916461,19.1252384185791,12,1.28160685785064,-3.04025420546672 +-162.58339,55.2425289,13.719616,-544278.114169786,616339.767871923,28.7757625579834,12,1.45902684126225,-2.39581418501078 +-161.77345,55.2997266,13.62108998,-492422.490657914,616339.810529119,46.9572525024414,12,1.67170267814722,-1.62331484171717 +-161.7155,55.3035961,13.719616,-488718.187044517,616339.769950735,111.673210144043,12,2.04794900049203,-0.256680807568719 +-161.65754,55.3074368,13.719616,-485013.99652431,616339.748234338,92.0353546142578,12,1.96395469000195,-0.561772117631749 +-161.59957,55.3112487,13.719616,-481309.91366436,616339.745383218,99.6803665161133,12,1.9986096261814,-0.435895497924441 +-161.54159,55.3150317,13.719616,-477605.934291069,616339.75034695,106.622177124023,12,2.02784754616209,-0.329695027221356 +-161.4836,55.3187858,13.719616,-473902.052937122,616339.763149423,67,12,1.82607480270083,-1.06259122314737 +-161.4256,55.322511,13.719616,-470198.26413251,616339.783826666,47,12,1.67209785793572,-1.62187943592981 +-161.36758,55.3262073,13.719616,-466493.931833083,616339.742183343,44,12,1.64345267648619,-1.72592691110329 +-161.30956,55.3298748,13.719616,-462790.310483026,616339.79039462,35,12,1.54406804435028,-2.08692026221913 +-161.25152,55.3335133,13.719616,-459086.135917909,616339.766464271,31.1000003814697,12,1.49276039435385,-2.27328429166744 +-161.19347,55.3371229,13.719616,-455382.031995535,616339.751789464,34.7000007629395,12,1.54032948433959,-2.10049977926921 +-161.13541,55.3407037,13.719616,-451677.992038331,616339.75754056,38.4276237487793,12,1.58464352980133,-1.93953851766432 +-161.07734,55.3442554,13.719616,-447974.014143689,616339.750605524,36.5999984741211,12,1.56348106728838,-2.01640662187954 +-161.01926,55.3477783,13.719616,-444270.089240135,616339.764326388,36.4952583312988,12,1.56223644214626,-2.02092745564709 +-160.96117,55.3512722,13.719616,-440566.214196545,616339.776685886,68.8124923706055,12,1.83766728816463,-1.02048400711806 +-160.90307,55.3547372,13.719616,-436862.382334829,616339.798904314,52.725399017334,12,1.7220198750947,-1.44054842044606 +-160.6124,55.3716274,11.44789046,-418342.43156311,616339.793763388,24.2780303955078,12,1.385213450811,-2.66392548756891 +-160.49606,55.3781806,13.45490043,-410934.44082492,616339.793601462,53.0793495178223,13,1.72492559198909,-1.42999402731145 +-160.43787,55.3814137,13.719616,-407230.133103413,616339.764126339,64.9351272583008,13,1.81247969598955,-1.1119725311525 +-160.37968,55.3846178,13.719616,-403526.450517308,616339.797148096,125.365127563477,13,2.09817674691763,-0.074239296124787 +-160.32147,55.3877929,11.05987117,-399822.126377063,616339.77085073,218.261749267578,13,2.33897763155164,0.800418248281181 +-160.26326,55.3909389,12.23806032,-396118.417325603,616339.795389115,74.4498977661133,13,1.87186410571958,-0.896271405014991 +-160.08856,55.4002027,13.719616,-385006.506809507,616339.79877917,53.3537368774414,13,1.7271648426624,-1.42186042972022 +-160.0303,55.4032326,13.719616,-381302.0464382,616339.763037151,66.2223739624023,112,1.82100474543284,-1.08100711828313 +-159.97204,55.4062334,13.719616,-377598.173289572,616339.776909792,143.882705688477,112,2.15800859605311,0.143087057645225 +-159.91377,55.4092051,13.719616,-373894.251200603,616339.78277372,119.198089599609,112,2.07626929497639,-0.153813414584692 +-159.85549,55.4121477,13.719616,-370190.274577557,616339.780991256,106.370780944824,112,2.02682234772278,-0.33341884057369 +-159.7972,55.4150613,13.719616,-366486.236853414,616339.783033874,130.931701660156,112,2.11704481224347,-0.00570509737932522 +-159.7389,55.4179457,13.719616,-362782.134382119,616339.767096651,151.076126098633,112,2.17919584009805,0.220045175457986 +-159.68059,55.4208011,13.719616,-359077.959631016,616339.755773647,144.766952514648,112,2.16066943217477,0.152751973917341 +-159.62228,55.4236274,13.719616,-355374.338540448,616339.791892007,146.300033569336,112,2.16524442577655,0.169369656512173 +-159.56395,55.4264245,13.719616,-351670.005295331,616339.757196316,150.006652832031,112,2.17611052055014,0.208838414222097 +-159.50562,55.4291926,13.719616,-347966.213558148,616339.780788478,150.700744628906,112,2.1781153982166,0.216120702155723 +-159.44728,55.4319315,13.719616,-344262.329003599,616339.787406293,146.188705444336,112,2.16491382027791,0.168168802976935 +-159.38893,55.4346413,13.719616,-340558.345089093,616339.788612744,139.927505493164,112,2.14590309197408,0.0991164115753229 +-159.33057,55.437322,13.719616,-336854.256202213,616339.784883243,137.578918457031,112,2.13855189102731,0.0724147514950107 +-159.2722,55.4399735,13.719616,-333150.057611967,616339.765601537,148.516860961914,112,2.17177576144474,0.193093331887835 +-159.21383,55.4425959,13.719616,-329446.373370554,616339.791978149,152.242736816406,112,2.18253658251477,0.232179705458339 +-159.15544,55.4451891,13.719616,-325741.93758066,616339.753648442,150.74153137207,112,2.17823292292371,0.216547585436844 +-159.09705,55.4477532,13.719616,-322038.004881609,616339.760899305,149.135971069336,112,2.17358240638243,0.199655581969357 +-159.03865,55.4502881,13.719616,-318333.939924216,616339.753554711,147.772506713867,112,2.16959364046522,0.185167245650904 +-158.98025,55.4527939,13.719616,-314630.366792106,616339.790648165,127.433807373047,120,2.10528465882996,-0.0484213312591734 +-158.92183,55.4552705,13.719616,-310926.019541374,616339.766324492,119.235206604004,120,2.07640450856091,-0.15332228025194 +-158.86341,55.4577179,13.719616,-307222.153658008,616339.775352719,101.924263000488,12,2.00827757981536,-0.400778730817196 +-158.80498,55.4601361,13.719616,-303518.132911795,616339.770943825,131.392684936523,12,2.11857118729275,-0.000160867529541897 +-158.74654,55.4625251,13.719616,-299813.951642187,616339.753697727,151.257110595703,120,2.17971579998494,0.221933818178479 +-158.6881,55.464885,13.719616,-296110.233972595,616339.779926604,161.924591064453,120,2.20931280893003,0.329438602494472 +-158.62965,55.4672156,13.719616,-292406.345248723,616339.78232953,163.9306640625,120,2.2146601981558,0.348861846459297 +-158.57119,55.4695171,13.719616,-288702.278243091,616339.783769517,149.222702026367,120,2.1738348996431,0.200572709560869 +-158.51272,55.4717893,13.719616,-284998.028830308,616339.762671252,137.860244750977,120,2.13943904518605,0.0756371486185762 +-158.45425,55.4740323,13.719616,-281294.221136684,616339.773167807,142.321304321289,120,2.15326991523988,0.125874816377435 +-158.39577,55.4762461,13.719616,-277590.218919889,616339.772463744,143.671112060547,120,2.15736945335404,0.140765508932729 +-158.33728,55.4784307,13.719616,-273886.016507407,616339.761248407,141.694122314453,120,2.15135183543206,0.118907803040928 +-158.27879,55.4805861,13.719616,-270182.23879656,616339.7809073,140.781967163086,120,2.14854702935781,0.108719946807912 +-158.22029,55.4827122,13.719616,-266478.250247598,616339.779239019,136.108596801758,120,2.13388555669235,0.0554652932860227 +-158.16178,55.4848091,13.719616,-262774.044456157,616339.768087679,130.88737487793,120,2.11689775743479,-0.00623924241809778 +-158.10327,55.4868767,13.719616,-259070.247002676,616339.776085161,125.484992980957,120,2.09859179071536,-0.0727317385861692 +-158.04475,55.4889151,13.719616,-255366.220927802,616339.774977041,123.544158935547,120,2.09182221714379,-0.0973207620267703 +-157.98622,55.4909243,13.719616,-251661.960549586,616339.765529728,120.415374755859,120,2.08068194161731,-0.13778542249016 +-157.92769,55.4929041,13.719616,-247958.092072987,616339.763617799,115.807739257812,120,2.0637375836112,-0.199332167169631 +-157.86915,55.4948548,13.719616,-244253.977236792,616339.764941515,110.564804077148,120,2.04361690067836,-0.272416230596381 +-157.81061,55.4967761,13.719616,-240550.242872097,616339.773163176,104.605728149414,120,2.01955546689806,-0.359814225903346 +-157.75206,55.4986682,13.719616,-236846.251402669,616339.774005393,97.5403060913086,21,1.98918411411753,-0.470131648049389 +-157.6935,55.5005311,13.719616,-233141.997139271,616339.768298995,97.9754867553711,21,1.99111742978879,-0.463109293708144 +-157.63494,55.5023646,13.719616,-229438.106181648,616339.769188441,94.1671676635742,21,1.97389950801576,-0.525649700071926 +-157.57637,55.5041689,13.719616,-225733.941008202,616339.764111874,94.1457443237305,21,1.97380069335436,-0.526008623126666 +-157.5178,55.5059439,13.719616,-222030.127086888,616339.776246724,93.0984191894531,21,1.9689423067265,-0.543655670080653 +-157.45922,55.5076896,13.719616,-218326.028122131,616339.771925663,93.0877151489258,21,1.96889237061545,-0.543837052289175 +-157.40064,55.509406,13.719616,-214622.268959978,616339.784359733,88.7700729370117,21,1.94826657671401,-0.618755822926896 +-157.34205,55.5110931,13.719616,-210918.213302253,616339.781023021,85.4390029907227,21,1.93165617182219,-0.679089554575539 +-157.28346,55.5127509,13.719616,-207214.485992443,616339.794037053,83.1946487426758,21,1.92009539244134,-0.721081605061745 +-157.22486,55.5143794,13.719616,-203510.450729861,616339.79201733,83.5234909057617,21,1.92180863759097,-0.714858609669446 +-157.16625,55.5159786,13.719616,-199806.101784057,616339.775909601,87.0539093017578,21,1.93978827861314,-0.649551421576445 +-157.10764,55.5175484,13.719616,-196102.064515961,616339.765072754,86.9829330444336,21,1.93943404788595,-0.65083808868511 +-157.04903,55.519089,13.719616,-192398.332140667,616339.781061686,86.3391342163086,21,1.93620768936351,-0.662557143733034 +-156.99041,55.5206003,13.719616,-188694.268883664,616339.783646937,85.7840805053711,21,1.93340670055096,-0.672731134582006 +-156.93179,55.5220822,13.719616,-184990.500072936,616339.79055178,86.8100891113281,21,1.93857020202844,-0.653975823405769 +-156.87316,55.5235348,13.719616,-181286.388889462,616339.784945113,92.4360275268555,21,1.96584127323895,-0.554919508830485 +-156.81452,55.5249581,13.719616,-177581.929595891,616339.767850815,89.5415115356445,21,1.95202442136359,-0.605106258563984 +-156.75589,55.526352,13.719616,-173878.378058906,616339.781538796,109.247352600098,21,2.03841092147679,-0.291325832990883 +-156.69725,55.5277166,13.719616,-170174.466914272,616339.78359412,164.383819580078,121,2.21585906738338,0.353216481685209 +-156.6386,55.5290519,13.719616,-166470.190421482,616339.775079759,197.477264404297,121,2.29551710243271,0.642557201651207 +-156.57995,55.5303578,13.719616,-162766.173843175,616339.770448236,225.709075927734,121,2.353549022729,0.853345700126463 +-156.5213,55.5316344,13.719616,-159062.410984493,616339.780247034,242.793197631836,220,2.38523651488946,0.968443716163962 +-156.46264,55.5328817,13.719616,-155358.265530506,616339.780511646,241.014678955078,220,2.38204349400662,0.956845752938613 +-156.40398,55.5340996,13.719616,-151654.362711462,616339.784059416,238.963775634766,220,2.37833207151602,0.943364807107293 +-156.34531,55.5352881,13.719616,-147950.066181064,616339.768066328,229.084655761719,220,2.35999600083852,0.876762964770991 +-156.28664,55.5364473,13.719616,-144246.000351506,616339.766527224,222.473129272461,220,2.34727756357125,0.830565970412873 +-156.22797,55.5375772,13.719616,-140542.159475675,616339.778923324,202.795547485352,220,2.30705841553423,0.684478545054641 +-156.16929,55.5386776,13.719616,-136837.907961847,616339.761874257,204.12109375,220,2.30988788676345,0.694755992170679 +-156.11062,55.5397488,13.719616,-133134.500083076,616339.790058618,197.878952026367,220,2.29639960165995,0.645762690734888 +-156.05193,55.5407905,13.719616,-129430.039437395,616339.769449963,196.903930664062,122,2.29425438576064,0.637970654283016 +-155.99325,55.5418029,13.719616,-125726.411261076,616339.781992964,197.713562011719,122,2.29603646043578,0.644443658157904 +-155.93456,55.5427859,13.719616,-122022.348984517,616339.777677314,205.736022949219,122,2.31331034030124,0.707187320285415 +-155.87587,55.5437396,13.719616,-118318.477083075,616339.786687808,215.386688232422,122,2.33321885863768,0.779500741340225 +-155.81717,55.5446638,13.719616,-114614.15984226,616339.769065361,222.54362487793,122,2.34741515772889,0.831065751666674 +-155.75847,55.5455588,13.719616,-110910.021136224,616339.776179642,211.060836791992,122,2.32440765565242,0.747495937130066 +-155.69977,55.5464243,13.719616,-107206.056095833,616339.77421841,178.889114379883,122,2.25258391402414,0.486611606999271 +-155.64107,55.5472604,13.719616,-103502.258632046,616339.773930094,193.941284179688,122,2.28767026695891,0.614055255500546 +-155.58236,55.5480672,13.719616,-99797.9921231028,616339.771050019,323.403869628906,122,2.50974521207139,1.42069484264906 +-155.52366,55.5488446,13.719616,-96094.512211569,616339.784691073,497.452178955078,221,2.69675133751561,2.09995446712478 +-155.46494,55.5495926,13.719616,-92389.9213969769,616339.771095445,666.855102539062,320,2.82403147858837,2.56227226887017 +-154.99518,55.5545186,13.719616,-62757.9083387735,616339.770812401,437.219879150391,420,2.64069989986744,1.8963596469135 +-154.93646,55.5550021,13.719616,-59054.4091042543,616339.780191003,441.655944824219,420,2.64508408054894,1.91228424251848 +-154.87773,55.5554562,13.719616,-55350.3716691198,616339.781288746,574.31640625,420,2.75915122276223,2.32660866104093 +-162.6336,55.205247,12.98022361,-547982.271760965,612635.784266789,47.3208694458008,12,1.67505271550037,-1.61114654985467 +-162.57589,55.2095447,13.719616,-544278.189533975,612635.776273797,67.3626708984375,12,1.82841929840633,-1.05407534555927 +-162.51817,55.2138137,10.79449274,-540574.298436162,612635.792253547,24.6706390380859,12,1.39218039906898,-2.6386195429309 +-161.82452,55.2628002,13.66212269,-496126.08178323,612635.76555622,92.3795623779297,12,1.96557590056802,-0.555883418116206 +-161.76664,55.2666953,13.719616,-492422.303376775,612635.784046526,107.746536254883,12,2.03240331772307,-0.313147164565205 +-161.70874,55.2705617,13.719616,-488718.00952844,612635.754969527,105.141143798828,12,2.02177269726694,-0.351760612343048 +-161.65084,55.2743992,13.719616,-485014.459658076,612635.803934778,104.738182067871,12,2.0201050316168,-0.357818049983525 +-161.59292,55.2782079,13.719616,-481310.384777296,612635.795387371,113.415534973145,12,2.05467254565942,-0.232258972429902 +-161.53499,55.2819878,13.719616,-477606.41058204,612635.802935692,73.8860778808594,12,1.86856261337282,-0.908263367558143 +-161.47704,55.2857388,13.719616,-473901.901758398,612635.744184876,54.8762817382812,12,1.73938467712921,-1.37747450304877 +-161.41909,55.2894609,13.719616,-470198.115097197,612635.762449638,63.5041809082031,12,1.80280231876582,-1.14712352742755 +-161.36113,55.2931542,13.719616,-466494.412767051,612635.796933337,48.7029762268066,12,1.68755550165374,-1.5657328618952 +-161.30315,55.2968186,13.719616,-462790.159417111,612635.766947072,54.6912994384766,12,1.73791824212131,-1.38280101355967 +-161.24516,55.3004542,13.719616,-459085.97948844,612635.754438544,61.6102714538574,12,1.78965312229207,-1.19488516217454 +-161.18717,55.3040608,13.719616,-455382.501066995,612635.805924652,47.0613174438477,12,1.67266408073598,-1.61982275310319 +-161.12916,55.3076386,13.719616,-451678.453998091,612635.805950023,38.9332618713379,12,1.59032079091,-1.91891708486597 +-161.07114,55.3111874,13.719616,-447974.466323867,612635.801609214,41.1584205627441,12,1.6144587005402,-1.83124130744376 +-161.0131,55.3147074,13.719616,-444269.899052376,612635.748276816,42.5819778442383,12,1.62922582964551,-1.77760287957499 +-160.95506,55.3181984,13.719616,-440566.011311202,612635.758291133,50.1616172790527,12,1.70037153029565,-1.51918138780898 +-160.89701,55.3216605,13.719616,-436862.165296633,612635.775420214,40.0616073608398,13,1.60272837016822,-1.87384921552444 +-160.60659,55.3385368,6.411465482,-418342.114252993,612635.770273978,11.700553894043,12,1.06820642135578,-3.81538550136478 +-160.31592,55.3546888,11.76257385,-399822.299690167,612635.783807844,73.7294158935547,13,1.86764079330618,-0.911611681153841 +-160.25775,55.3578322,13.719616,-396117.926514775,612635.746342657,139.448013305664,13,2.14441233131965,0.0937015433729826 +-160.19958,55.3609466,13.719616,-392414.160998658,612635.767828943,73.2654190063477,13,1.86489903769076,-0.921570520124024 +-160.1414,55.364032,13.43014842,-388710.366461695,612635.788368005,53.2434120178223,13,1.72626587875289,-1.42512572322943 +-160.0832,55.3670884,13.719616,-385005.90622153,612635.750304456,93.21142578125,13,1.96946915108368,-0.541742020999031 +-160.025,55.3701157,13.719616,-381302.037990294,612635.759380191,63.9606552124023,13,1.80591290400592,-1.13582499398608 +-159.96679,55.373114,13.719616,-377598.124052643,612635.768497634,95.8494567871094,112,1.98158965592009,-0.49771688789668 +-159.90857,55.3760832,13.719616,-373894.159838478,612635.766917574,96.0669479370117,13,1.98257399331258,-0.494141493529297 +-159.85034,55.3790234,13.719616,-370190.138776736,612635.76610015,77.3014221191406,13,1.88818748373481,-0.83698023690774 +-159.7921,55.3819346,13.719616,-366486.055303328,612635.766425476,89.7402114868164,13,1.952987088681,-0.601609576094527 +-159.73385,55.3848166,13.719616,-362781.905773035,612635.746091934,113.116348266602,112,2.05352537635679,-0.236425818771777 +-159.6756,55.3876696,13.719616,-359078.313786835,612635.781764216,117.3056640625,112,2.06931898237726,-0.179058933761473 +-159.61733,55.3904935,13.719616,-355374.012456956,612635.754065252,120.971138000488,112,2.08268176616525,-0.130521488925281 +-159.55906,55.3932884,13.719616,-351670.257508828,612635.782102555,133.276214599609,112,2.12475264911487,0.0222919661732748 +-159.50078,55.3960541,13.719616,-347966.414081862,612635.790048591,141.029205322266,112,2.14930905873265,0.111487855002165 +-159.44249,55.3987908,13.719616,-344262.474717456,612635.800556187,141.631408691406,112,2.15115957474325,0.118209457342508 +-159.38419,55.4014983,13.719616,-340558.435641224,612635.791888562,144.090072631836,112,2.15863406027456,0.145358922222812 +-159.32588,55.4041768,13.719616,-336854.289429526,612635.786727103,152.494094848633,112,2.18325302647423,0.234782034412539 +-159.26756,55.4068261,13.719616,-333150.032265046,612635.76335687,160.363250732422,112,2.20510485127544,0.314154099222296 +-159.20924,55.4094463,13.719616,-329446.288761237,612635.782990223,169.694107055664,112,2.22966676089372,0.403369965622883 +-159.15091,55.4120374,13.719616,-325742.422173306,612635.795420132,164.361068725586,112,2.21579895651363,0.352998141848942 +-159.09257,55.4145993,13.719616,-322038.427737078,612635.790068514,168.811370849609,112,2.22740169661972,0.395142605665995 +-159.03422,55.4171321,13.719616,-318334.298960329,612635.778580934,160.880508422852,112,2.2065034300706,0.319234136600441 +-158.97586,55.4196358,13.719616,-314630.030221795,612635.761510934,157.905899047852,120,2.19839835468262,0.289794189372462 +-158.9175,55.4221103,13.719616,-310926.247851634,612635.775134473,157.41389465332,120,2.19704306414081,0.284871387286167 +-158.85913,55.4245557,13.719616,-307222.314252141,612635.783203596,134.435607910156,120,2.12851431537478,0.0359554117157171 +-158.80075,55.4269719,13.719616,-303518.224601123,612635.775199668,135.938812255859,120,2.13334347102261,0.0534962834068838 +-158.74236,55.429359,13.719616,-299813.972445997,612635.762835567,152.933532714844,120,2.18450272070551,0.239321280558815 +-158.68397,55.4317168,13.719616,-296110.184855697,612635.76909245,168.043930053711,120,2.22542282985644,0.387954796756956 +-158.62557,55.4340456,13.719616,-292406.22268469,612635.782229625,171.476821899414,120,2.23420542582799,0.419855692128099 +-158.56716,55.4363451,13.719616,-288702.082624933,612635.769552457,156.721954345703,120,2.19512983873619,0.277922006527689 +-158.50875,55.4386154,13.719616,-284998.389355868,612635.785739782,143.030303955078,120,2.15542806156417,0.133713819823527 +-158.45033,55.4408566,13.719616,-281294.505335931,612635.798542016,144.166595458984,120,2.15886464257173,0.146196462940858 +-158.3919,55.4430685,13.719616,-277590.426398627,612635.786409451,144.531616210938,120,2.15996285916207,0.150185499059188 +-158.33346,55.4452513,13.719616,-273886.145392149,612635.772262934,139.396438598633,120,2.14425167823316,0.093118005507887 +-158.27502,55.4474049,13.719616,-270182.288520242,612635.786375396,135.82878112793,120,2.13299180352824,0.0522189266914254 +-158.21657,55.4495292,13.719616,-266478.219687536,612635.776547769,128.537750244141,120,2.10903069432103,-0.0348146611306338 +-158.15811,55.4516243,13.719616,-262773.932493114,612635.754625551,125.709785461426,120,2.09936908521572,-0.0699083830989073 +-158.09965,55.4536903,13.719616,-259070.051702837,612635.771479747,121.577545166016,120,2.08485337007642,-0.122633603682453 +-158.04118,55.4557269,13.719616,-255365.942571539,612635.754384864,118.257675170898,120,2.07282933694641,-0.166308324011383 +-157.98271,55.4577344,13.719616,-251662.228487566,612635.775358945,110.596420288086,120,2.04374107023911,-0.27196521131021 +-157.92423,55.4597127,13.719616,-247958.273328287,612635.785054466,105.012023925781,120,2.02123902883803,-0.353699048400966 +-157.86574,55.4616617,13.719616,-244254.072059641,612635.773144379,99.0690155029297,120,1.99593784721815,-0.445600161720575 +-157.80725,55.4635814,13.719616,-240550.250097863,612635.776654974,96.5292358398438,120,1.98465886817236,-0.486568632956017 +-157.74875,55.4654719,13.719616,-236846.16997086,612635.770189285,93.7275543212891,21,1.97186728491674,-0.533031314421806 +-157.69025,55.4673332,13.719616,-233142.457121403,612635.789685702,94.9294738769531,21,1.97740107391073,-0.512931013294983 +-157.63174,55.4691652,13.719616,-229438.475341361,612635.788644917,94.7926330566406,21,1.97677458684049,-0.515206593151313 +-157.57322,55.470968,13.719616,-225734.218313057,612635.779047257,92.6265487670898,21,1.96673548269187,-0.551671484864726 +-157.5147,55.4727415,13.719616,-222030.312064444,612635.784072244,89.8622207641602,21,1.9535771471048,-0.599466315479836 +-157.45617,55.4744857,13.719616,-218326.119745054,612635.770054064,87.9471969604492,21,1.94422200224705,-0.633446871827385 +-157.39764,55.4762007,13.719616,-214622.266191831,612635.781330717,88.8257751464844,21,1.94853900608956,-0.617766281675804 +-157.3391,55.4778864,13.719616,-210918.115141005,612635.774253419,86.9340209960938,21,1.93918976769637,-0.651725384058195 +-157.28056,55.4795428,13.719616,-207214.291996644,612635.780945161,85.5528259277344,21,1.93223435945925,-0.676989412046553 +-157.22201,55.4811699,13.719616,-203510.159903178,612635.770022905,87.0114974975586,21,1.93957664307643,-0.650320142252591 +-157.16346,55.4827678,13.719616,-199806.343731756,612635.783647576,88.1525726318359,21,1.94523499120717,-0.629767406788378 +-157.1049,55.4843364,13.719616,-196102.207174457,612635.780451087,84.3011856079102,21,1.92583368256486,-0.700238497462047 +-157.04634,55.4858756,13.719616,-192398.376141336,612635.779248937,87.6769180297852,21,1.94288527533073,-0.638302245527282 +-156.98777,55.4873856,13.719616,-188694.212740589,612635.773197317,84.93359375,21,1.92907950054508,-0.688448760109223 +-156.9292,55.4888663,13.719616,-184990.342889783,612635.780022722,85.7424850463867,21,1.93319606637188,-0.673496218041429 +-156.87062,55.4903177,13.719616,-181286.129726338,612635.771766433,90.1727981567383,21,1.95507554649854,-0.594023701196004 +-156.81204,55.4917398,13.719616,-177582.198644974,612635.776193429,89.0931777954102,21,1.94984444972438,-0.613024537783423 +-156.75345,55.4931326,13.719616,-173877.912780944,612635.766486507,100.442344665527,121,2.00191684206772,-0.423882745851916 +-156.69486,55.494496,13.719616,-170173.897978777,612635.758190064,138.049468994141,121,2.14003474046925,0.0778008839154993 +-156.63627,55.4958302,13.719616,-166470.147587164,612635.77295683,179.392700195312,121,2.25380476686083,0.491046092968232 +-156.57767,55.497135,13.719616,-162766.025632311,612635.763419292,209.722274780273,121,2.32164455969953,0.737459583963047 +-156.51907,55.4984106,13.719616,-159062.156629397,612635.776882267,213.367492675781,220,2.32912825376267,0.764642496859347 +-156.46046,55.4996568,13.719616,-155357.904563398,612635.767118161,214.802764892578,220,2.33203986720378,0.775218307934667 +-156.40185,55.5008737,13.719616,-151653.894389695,612635.76921088,217.143310546875,220,2.33674645475591,0.792313977317834 +-156.34324,55.5020612,13.719616,-147950.120758841,612635.771483099,214.12776184082,220,2.33067297758241,0.770253374680688 +-156.28462,55.5032194,13.719616,-144245.946385644,612635.762816599,208.966842651367,220,2.32007738086735,0.731767143127218 +-156.226,55.5043483,13.719616,-140541.996655086,612635.765529301,204.293670654297,220,2.31025491170101,0.696089131503222 +-156.16738,55.5054479,13.719616,-136838.265822091,612635.779116546,208.36003112793,220,2.31881441364205,0.727179685678193 +-156.10875,55.5065181,13.719616,-133134.117365234,612635.771904906,205.532821655273,220,2.3128811844874,0.705628503876276 +-156.05012,55.507559,13.719616,-129430.176293662,612635.775712491,201.116317749023,122,2.30344730889041,0.671361975011853 +-155.99149,55.5085705,13.719616,-125726.437193883,612635.77893839,206.798065185547,122,2.31554647115705,0.715309585809025 +-155.93285,55.5095527,13.719616,-122022.262834738,612635.77389131,205.220413208008,122,2.31222055771982,0.703228918894791 +-155.87421,55.5105056,13.719616,-118318.27859641,612635.779621239,213.786163330078,122,2.3299795933711,0.767734805313676 +-155.81557,55.5114291,13.719616,-114614.479033678,612635.78456563,218.842498779297,122,2.34013166497888,0.804610027082834 +-155.75692,55.5123232,13.719616,-110910.227237396,612635.77160995,214.289993286133,122,2.33100189123743,0.771448082957042 +-155.69827,55.513188,13.719616,-107206.148271277,612635.769306375,192.95930480957,122,2.28546572579426,0.606047732751853 +-155.63962,55.5140235,13.719616,-103502.236383535,612635.777268029,346.224609375,122,2.53935793394931,1.52825670082198 +-155.58097,55.5148296,13.719616,-99798.4860869371,612635.783983693,558.107360839844,122,2.74671775043468,2.28144674068096 +-155.52231,55.5156063,13.719616,-96094.2604697398,612635.774622323,665.577514648438,221,2.82319864166449,2.55924716744735 +-154.99431,55.5212756,13.719616,-62758.4967939918,612635.781200457,536.119689941406,420,2.72926175774922,2.21804159281102 +-154.93563,55.5217587,13.719616,-59054.2484134908,612635.780059878,588.638061523438,420,2.76984834029022,2.36546364516394 +-162.5684,55.1765584,13.719616,-544278.074460919,608931.75508986,42.07177734375,12,1.62399085939704,-1.79661778572672 +-162.51073,55.1808239,11.34228076,-540574.228401395,608931.777338363,67.5320205688477,12,1.82950974407488,-1.05011453564692 +-161.99111,55.2179216,12.97077382,-507238.41672815,608931.802216889,63.6813354492188,12,1.8040121623324,-1.14272903027002 +-161.81768,55.2297701,13.719616,-496126.390465766,608931.792594713,95.0027847290039,12,1.977736335549,-0.511713247331582 +-161.75984,55.2336621,13.719616,-492421.997661011,608931.750692675,116.857269287109,12,2.06765573352828,-0.185100328319466 +-161.702,55.2375253,12.13323217,-488718.351994249,608931.79566101,84.5427169799805,12,1.92707620079667,-0.69572531659412 +-161.4705,55.2526899,13.70908319,-473902.291041041,608931.789749955,31.6144256591797,12,1.49988529637177,-2.24740461388887 +-161.4126,55.2564089,13.719616,-470198.511968707,608931.805041421,43.991943359375,12,1.64337314751019,-1.72621578304396 +-161.35468,55.2600992,13.719616,-466494.18279807,608931.774599849,52.8453941345215,12,1.72300714132879,-1.43696238769003 +-161.29675,55.2637606,13.719616,-462789.932245809,608931.747718419,71.3000030517578,12,1.85308954844039,-0.964465955845183 +-161.23882,55.2673931,13.719616,-459086.386525794,608931.793603594,68.0632629394531,12,1.832912765251,-1.03775379141633 +-161.18087,55.2709968,13.719616,-455382.275586626,608931.784604049,60.7564239501953,12,1.78359220389381,-1.21690014775536 +-161.12291,55.2745716,13.66228173,-451678.226858141,608931.779438748,62.2000007629395,12,1.79379039001783,-1.1798574249008 +-161.06494,55.2781175,13.719616,-447974.234859519,608931.778222579,42.2413101196289,12,1.62573737943347,-1.79027392644795 +-161.00696,55.2816345,13.719616,-444270.294107384,608931.781082593,53.8699035644531,13,1.73134619809165,-1.40667255332353 +-160.94897,55.2851227,13.719616,-440566.397952638,608931.799234084,53.0187644958496,13,1.72442960308612,-1.43179560057638 +-160.89096,55.2885819,13.70814471,-436861.911556002,608931.744895817,43.1334114074707,13,1.63481380771355,-1.75730574826414 +-160.54273,55.3087299,12.98202091,-414638.061264246,608931.760500852,49.4421806335449,13,1.6940976169398,-1.54197003187061 +-160.31038,55.3215829,9.053454164,-399822.491015346,608931.800199859,58.1507797241211,13,1.76455554241121,-1.28604673586434 +-160.25226,55.3247237,13.719616,-396118.089769924,608931.760294752,151.001831054688,13,2.17898221359864,0.21926922303703 +-160.19414,55.3278356,13.719616,-392414.294337319,608931.787722379,161.318405151367,13,2.20768391977381,0.323522012147825 +-160.13601,55.3309184,13.16215097,-388710.469566561,608931.800409081,38.8752708435059,13,1.58967342776944,-1.92126849256835 +-160.01971,55.336997,12.7380453,-381302.074978117,608931.758703384,51.7789459228516,13,1.71415320514581,-1.46912241107159 +-159.96155,55.3399929,13.719616,-377598.124741098,608931.774055365,117.763542175293,13,2.07101086020714,-0.172913550573322 +-159.90338,55.3429596,13.719616,-373894.123900323,608931.764925017,93.4812927246094,13,1.97072470948915,-0.537181474498295 +-159.8452,55.3458974,13.719616,-370190.063901031,608931.764961499,81.4902038574219,13,1.91110540424461,-0.753735808190361 +-159.78701,55.3488061,13.719616,-366485.941149551,608931.752358638,86.4311676025391,13,1.93667037994344,-0.660876519481699 +-159.72882,55.3516858,13.719616,-362782.380780456,608931.793232176,107.081161499023,112,2.02971307329077,-0.322918900215523 +-159.67061,55.3545364,13.719616,-359078.114804063,608931.767080836,129.645126342773,112,2.11275619528799,-0.0212825782547985 +-159.6124,55.357358,13.719616,-355374.400057133,608931.794116182,119.055183410645,112,2.07574830841486,-0.155705786480559 +-159.55417,55.3601505,13.719616,-351669.968526389,608931.756091102,131.486663818359,112,2.1188817062569,0.000967025979178013 +-159.49594,55.3629139,13.719616,-347966.077984647,608931.759912869,142.890182495117,112,2.15500239089968,0.132167662471602 +-159.4377,55.3656483,13.719616,-344262.090230903,608931.763626108,153.800842285156,112,2.18695871387109,0.248242148746445 +-159.37945,55.3683536,13.719616,-340558.000590501,608931.75659906,158.405181884766,112,2.19976938449558,0.294774160984014 +-159.3212,55.3710298,13.719616,-336854.435143304,608931.790034412,162.513854980469,112,2.2108903922999,0.33516883558096 +-159.26293,55.373677,13.719616,-333150.124024625,608931.773525263,171.834167480469,112,2.23510952313238,0.423139631592678 +-159.20466,55.376295,13.719616,-329446.326770623,608931.786258312,175.263916015625,112,2.24369251114001,0.45431549386509 +-159.14638,55.3788839,13.719616,-325742.405189946,608931.789131385,174.587936401367,112,2.24201423172167,0.448219503989023 +-159.08809,55.3814437,13.719616,-322038.353667779,608931.782674915,172.079284667969,112,2.23572859202492,0.425388266510254 +-159.02979,55.3839744,13.719616,-318334.166587418,608931.767431959,169.970901489258,112,2.23037457782344,0.405940958742688 +-158.97149,55.386476,13.719616,-314630.470017245,608931.791334413,168.048324584961,120,2.22543418698024,0.387996049072254 +-158.91317,55.3889485,13.719616,-310925.994962982,608931.759640448,166.592681884766,120,2.22165591971861,0.374272303953147 +-158.85485,55.3913918,13.719616,-307221.999989829,608931.756016766,166.677337646484,120,2.22187655481215,0.375073713588407 +-158.79653,55.393806,13.719616,-303518.478640713,608931.790491165,170.999496459961,120,2.23299483153261,0.41545846810924 +-158.73819,55.3961911,13.719616,-299814.161915959,608931.771706258,162.523696899414,120,2.21091669259084,0.335264365744508 +-158.67985,55.398547,13.719616,-296110.308346152,608931.780018094,171.182464599609,120,2.23345927484073,0.417145458769645 +-158.6215,55.4008738,13.719616,-292406.27981127,608931.781465005,170.936431884766,120,2.23283463428481,0.414876585980404 +-158.56314,55.4031714,13.719616,-288702.071445046,608931.765578796,161.900909423828,120,2.2092492882632,0.329207877301932 +-158.50478,55.4054399,13.719616,-284998.30851743,608931.78704191,144.199829101562,120,2.15896474567958,0.146560066000844 +-158.44641,55.4076792,13.719616,-281294.354452319,608931.791380409,144.998306274414,120,2.16136292926965,0.155270953309728 +-158.38803,55.4098893,13.719616,-277590.203584374,608931.779274703,143.600189208984,120,2.15715501213723,0.139986597225638 +-158.32965,55.4120702,13.719616,-273886.481933547,608931.792659041,140.697982788086,120,2.14828787092243,0.107778609399408 +-158.27125,55.414222,13.719616,-270181.919741446,608931.760315504,132.774703979492,120,2.12311534183498,0.0163447987986732 +-158.21286,55.4163446,13.719616,-266478.407134143,608931.793898104,126.442855834961,120,2.10189429624187,-0.060736095884938 +-158.15445,55.4184379,13.719616,-262774.044075421,608931.760971098,123.495880126953,120,2.09165246959589,-0.0979373335715189 +-158.09604,55.4205021,13.719616,-259070.08686331,608931.76420618,118.33358001709,120,2.07310800368712,-0.165296126869723 +-158.03762,55.4225371,13.719616,-255365.898842152,608931.753118214,112.636047363281,21,2.05167740175511,-0.243138189989545 +-157.9792,55.4245429,13.719616,-251662.106022508,608931.766371735,108.46883392334,120,2.03530497136929,-0.302607530307719 +-157.92077,55.4265195,13.719616,-247958.071039569,608931.765739397,89.0245819091797,120,1.94950994275109,-0.614239562588207 +-157.86234,55.4284669,13.719616,-244254.419900929,608931.7887959,91.7653961181641,120,1.96267894364036,-0.566405992551328 +-157.8039,55.4303851,13.719616,-240550.515238863,608931.798455016,89.9429702758789,21,1.95396722560599,-0.598049439024028 +-157.74545,55.432274,13.719616,-236846.351999052,608931.78441638,88.2853927612305,21,1.94588885343064,-0.627392392561892 +-157.68699,55.4341337,13.719616,-233141.923850392,608931.758634531,89.5787048339844,21,1.95220477894457,-0.60445114835067 +-157.62854,55.4359642,13.719616,-229438.488481744,608931.791052803,90.4967803955078,21,1.95663312858269,-0.588366118488191 +-157.57007,55.4377655,13.719616,-225734.145145918,608931.77721321,89.15478515625,21,1.95014465778825,-0.611934096407554 +-157.5116,55.4395375,13.719616,-222030.152117805,608931.775403275,83.9416275024414,21,1.92397738527668,-0.706981099052727 +-157.45313,55.4412803,13.719616,-218326.503100036,608931.795958091,84.7527923583984,21,1.92815401585289,-0.691810384670876 +-157.39464,55.4429938,13.719616,-214621.929597542,608931.762343489,88.3517761230469,21,1.94621528449004,-0.626206701781443 +-157.33616,55.4446781,13.719616,-210918.320390764,608931.783546419,86.3188171386719,21,1.93610548040438,-0.662928395845936 +-157.27767,55.4463331,13.719616,-207214.406962498,608931.783615237,86.0497131347656,21,1.93474942685189,-0.667853969404801 +-157.21917,55.4479589,13.719616,-203510.183049466,608931.774612043,88.6022109985352,21,1.94744455949972,-0.621741624076268 +-157.16067,55.4495554,13.719616,-199806.27517323,608931.776446269,90.2220840454102,21,1.95531285467222,-0.593161730174695 +-157.10216,55.4511227,13.719616,-196102.045400751,608931.770005118,88.7740707397461,21,1.94828613493352,-0.618684781891155 +-157.04365,55.4526607,13.719616,-192398.120231623,608931.774107414,84.7093276977539,21,1.92793123494252,-0.692619588525341 +-156.98514,55.4541694,13.719616,-188694.493937573,608931.788067398,90.4020156860352,21,1.95617811401035,-0.590018861289015 +-156.92661,55.4556489,13.719616,-184989.896924579,608931.766630449,88.9914245605469,21,1.94934815894302,-0.614827207556823 +-156.86809,55.457099,13.719616,-181286.219514235,608931.772118718,91.1199188232422,21,1.95961332416769,-0.577541197490966 +-156.80956,55.4585199,13.719616,-177582.191629376,608931.770990616,92.9105758666992,21,1.96806515187448,-0.546841746868113 +-156.75103,55.4599116,13.719616,-173878.439253686,608931.790468944,95.520133972168,121,1.98009492290728,-0.503146184838457 +-156.69249,55.4612739,13.719616,-170174.325898963,608931.782048516,123.184028625488,121,2.09055440320617,-0.101925824118327 +-156.63395,55.4626069,13.719616,-166470.47704626,608931.782991104,159.963195800781,121,2.2040200720355,0.310213871396031 +-156.5754,55.4639107,13.719616,-162766.254840998,608931.779324363,180.545318603516,121,2.25658623199841,0.501149168257115 +-156.51685,55.4651851,13.719616,-159062.286106966,608931.773828408,192.425262451172,121,2.28426208757148,0.601675775174159 +-156.45829,55.4664303,13.719616,-155357.932565568,608931.764804228,200.811920166016,220,2.30278948889466,0.668972585026746 +-156.39974,55.4676462,13.719616,-151654.452283928,608931.787909137,201.470855712891,220,2.30421223103045,0.67414039055497 +-156.34117,55.4688327,13.719616,-147949.944854314,608931.762960352,202.116424560547,220,2.30560160696497,0.679187000516536 +-156.28261,55.46999,13.719616,-144246.29880201,608931.780200712,201.47575378418,220,2.30422278927952,0.674178741129224 +-156.22404,55.4711179,13.719616,-140542.245787256,608931.772849066,207.415069580078,220,2.31684030652611,0.720009165166833 +-156.16547,55.4722166,13.719616,-136838.410999007,608931.78494668,213.467926025391,220,2.329332630665,0.765384852103583 +-156.10689,55.4732859,13.719616,-133134.157743485,608931.773688226,214.124618530273,122,2.33066660226501,0.770230217708207 +-156.04831,55.4743259,13.719616,-129430.111590815,608931.770892288,196.531341552734,122,2.2934318187217,0.634982856013588 +-155.98973,55.4753366,13.719616,-125726.266796391,608931.776094326,211.965179443359,122,2.32626452310964,0.754240609737429 +-155.93114,55.476318,13.719616,-122021.9859279,608931.770469098,199.255828857422,122,2.29941103472856,0.656701075188677 +-155.87255,55.47727,13.719616,-118317.895240233,608931.761931855,206.25993347168,221,2.31441487333373,0.711199299524551 +-155.81396,55.4781928,13.719616,-114613.988348602,608931.772328094,212.291000366211,221,2.32693158354829,0.756663563648615 +-155.75537,55.4790862,13.719616,-110910.26012377,608931.778974114,218.526733398438,221,2.33950457383382,0.802332253054349 +-155.69677,55.4799503,13.719616,-107206.072816518,608931.776463473,355.593017578125,221,2.55095322457865,1.5703741060132 +-155.63817,55.480785,13.719616,-103502.05263968,608931.770531659,529.003723144531,221,2.72345872862391,2.19696333467848 +-162.56093,55.1435701,12.57206107,-544278.401296343,605227.798297146,17.0514907836914,12,1.23176235463806,-3.22130366817244 +-162.5033,55.1478321,13.58657007,-540573.973439452,605227.744925334,120.395042419434,12,2.08060860407952,-0.138051805360029 +-161.98413,55.1848993,11.77393711,-507238.521501904,605227.809396164,25.7178802490234,12,1.41023516976967,-2.5730394624014 +-161.92638,55.1888744,13.54530978,-503534.411544597,605227.805100174,82.1466445922852,12,1.91458982869845,-0.741079384020254 +-161.86862,55.1928206,13.69265974,-499830.433043539,605227.799176508,67.4775543212891,12,1.82915933349005,-1.05138732690819 +-161.81084,55.1967382,13.56605579,-496125.94439044,605227.750057206,92.5274200439453,12,1.96627045283753,-0.553360606028416 +-161.75306,55.2006269,13.719616,-492422.208605992,605227.774515406,123.297393798828,12,2.0909538967843,-0.100474749415749 +-161.34825,55.2270422,11.21345889,-466494.507532162,605227.80555419,16.6153106689453,12,1.22050846602083,-3.26218100380986 +-161.29037,55.2307006,13.68438653,-462790.265218373,605227.781206224,56.743480682373,12,1.75391597218568,-1.32469269175914 +-161.23248,55.2343302,13.719616,-459086.0933518,605227.768795307,56.7082252502441,12,1.75364605574859,-1.32567310530047 +-161.17458,55.2379309,13.719616,-455381.987688906,605227.757347102,50.2688484191895,12,1.70129893633371,-1.51581278437074 +-161.11667,55.2415027,13.719616,-451677.942753902,605227.74696737,78.5999984741211,13,1.89542253760835,-0.810700456149048 +-161.05875,55.2450457,13.719616,-447973.951886995,605227.74884748,37.6636505126953,13,1.57592241129099,-1.97121610934892 +-161.00082,55.2485598,13.719616,-444270.010808031,605227.752046141,50.6595458984375,13,1.70466129254717,-1.50359974689142 +-160.94288,55.2520451,13.719616,-440566.112871467,605227.767781168,48.7692222595215,13,1.68814582979515,-1.56358862158917 +-160.88493,55.2555015,13.69623099,-436862.25377283,605227.785133352,25.9111404418945,13,1.41348652825876,-2.56122960033889 +-160.537,55.2756328,12.06993499,-414638.344955348,605227.786347527,59.7129707336426,13,1.77606867796681,-1.24422774135031 +-160.47897,55.2788868,12.5018695,-410933.972731176,605227.74851682,37.6228179931641,13,1.57545132159837,-1.9729272415749 +-160.30484,55.2884752,10.17336984,-399822.069687803,605227.760755481,26.801420211792,13,1.42815780797663,-2.50793932480345 +-160.24678,55.2916134,13.719616,-396118.278100358,605227.778530949,83.1671676635742,13,1.91995191142656,-0.721602769060976 +-160.18871,55.2947227,13.719616,-392414.459273628,605227.800722619,218.093002319336,13,2.33864173113187,0.799198162081058 +-160.13062,55.297803,13.6895979,-388709.976472915,605227.758023323,67.7863159179688,13,1.83114203131357,-1.04418560249486 +-160.07253,55.3008543,10.62101772,-385006.088639588,605227.768375748,21.6836013793945,13,1.33613141482694,-2.84220545167084 +-160.01443,55.3038766,12.54472348,-381302.157978766,605227.773026675,61.4876937866211,13,1.7887882043062,-1.19802679117141 +-159.95632,55.3068699,13.719616,-377598.178938048,605227.772323917,113.597244262695,13,2.0553677960227,-0.229733624666269 +-159.8982,55.3098342,13.719616,-373894.145962859,605227.766627731,68.9537353515625,13,1.83855779768563,-1.01724942236107 +-159.84007,55.3127696,13.719616,-370190.05251832,605227.767405153,80.0963821411133,13,1.90361289995895,-0.780950722329514 +-159.78193,55.3156759,13.719616,-366485.895011558,605227.752853389,74.6153411865234,13,1.87282812918419,-0.892769796631845 +-159.72379,55.3185532,13.719616,-362782.299138424,605227.789090168,100.382827758789,112,2.00165942548372,-0.424817756359004 +-159.66563,55.3214014,13.719616,-359077.995795486,605227.755617155,118.955513000488,112,2.07538457424389,-0.157026972809579 +-159.60747,55.3242207,13.719616,-355374.241999219,605227.78374577,132.247695922852,112,2.12138811430489,0.0100710154095778 +-159.5493,55.3270109,13.719616,-351670.401826032,605227.797089159,145.929443359375,112,2.16414292587857,0.165368694483363 +-159.49112,55.329772,13.719616,-347966.469677536,605227.79609211,166.210830688477,112,2.2206593200196,0.370652369388481 +-159.43293,55.3325041,13.719616,-344262.439043166,605227.792312408,176.769805908203,112,2.24740808507005,0.467811518909378 +-159.37473,55.3352072,13.719616,-340558.304349671,605227.786222421,172.575469970703,112,2.23697906476586,0.429930340425809 +-159.31652,55.3378812,13.719616,-336854.060912502,605227.767204893,172.928787231445,112,2.23786729573258,0.433156648823264 +-159.25831,55.3405261,13.719616,-333150.335369979,605227.785919596,179.970367431641,112,2.25520100332362,0.496117622326666 +-159.20009,55.343142,13.719616,-329446.488997891,605227.802697471,182.902648925781,112,2.26221999528243,0.521612604540801 +-159.14186,55.3457287,13.719616,-325742.517938196,605227.795851826,181.495620727539,112,2.25886615049164,0.509430482978046 +-159.08362,55.3482864,13.719616,-322038.414846055,605227.788123649,181.24479675293,112,2.25826554752481,0.507248921573385 +-159.02537,55.350815,13.719616,-318334.174978691,605227.768954424,179.580825805664,112,2.25425996433943,0.492699500136805 +-158.96712,55.3533146,13.719616,-314630.424132636,605227.797385108,178.904052734375,120,2.25262017880236,0.486743331024794 +-158.90885,55.355785,13.719616,-310925.893875144,605227.756462956,184.411209106445,120,2.26578731533543,0.534570129187812 +-158.85059,55.3582263,13.719616,-307222.47447871,605227.798332532,170.431198120117,120,2.23154909706931,0.410207147884829 +-158.79231,55.3606385,13.719616,-303518.263587991,605227.783134214,172.667541503906,120,2.23721070542725,0.43077172542479 +-158.73403,55.3630216,13.719616,-299814.520069253,605227.803440073,176.414001464844,120,2.24653305085027,0.464633144863482 +-158.67573,55.3653755,13.719616,-296109.974591858,605227.757912214,172.701873779297,120,2.23729704959754,0.431085352096349 +-158.61744,55.3677003,13.719616,-292406.517460203,605227.792056014,174.610931396484,120,2.24207142892605,0.448427260561036 +-158.55913,55.3699961,13.719616,-288702.245547922,605227.783867432,171.727783203125,120,2.23484056374385,0.422162694324901 +-158.50082,55.3722626,13.719616,-284998.420006524,605227.788171018,148.104705810547,120,2.1705688578128,0.188709513412064 +-158.4425,55.3745,13.719616,-281294.401412075,605227.783831489,144.154937744141,120,2.15882952288313,0.146068898207716 +-158.38417,55.3767083,13.719616,-277590.184131267,605227.77153328,138.645202636719,120,2.14190484683529,0.0845936440184776 +-158.32584,55.3788875,13.719616,-273886.394773836,605227.793214588,135.241516113281,120,2.13111003074163,0.0453837908190119 +-158.2675,55.3810374,13.719616,-270182.396889078,605227.784997653,128.922164916992,120,2.11032758976311,-0.0301039667141801 +-158.20915,55.3831582,13.719616,-266478.183369295,605227.769833421,125.214714050293,120,2.09765536605791,-0.076133100224217 +-158.1508,55.3852499,13.719616,-262774.380819462,605227.788025045,123.969200134277,120,2.09331379908777,-0.091902910666358 +-158.09244,55.3873124,13.719616,-259070.35203961,605227.788519786,118.560424804688,120,2.07393974672501,-0.162274998753006 +-158.03407,55.3893457,13.719616,-255366.091357665,605227.772076509,108.524864196777,21,2.03552925105414,-0.301792882476554 +-157.9757,55.3913498,13.719616,-251662.225344709,605227.777361518,98.7227249145508,120,1.99441713411847,-0.451123825753361 +-157.91732,55.3933247,13.719616,-247958.116080992,605227.766149193,89.6331253051758,120,1.95246853955735,-0.603493094520278 +-157.85894,55.3952705,13.719616,-244254.389487769,605227.787135896,90.1282043457031,21,1.95486071855876,-0.594804017591306 +-157.80055,55.3971871,13.719616,-240550.408308793,605227.792118337,81.3302383422852,21,1.91025204502347,-0.756835452454535 +-157.74215,55.3990744,13.719616,-236846.167491968,605227.770798304,86.1587677001953,21,1.9352994787668,-0.665856023849393 +-157.68375,55.4009326,13.719616,-233142.292336727,605227.781359103,83.8405380249023,21,1.92345405662076,-0.708881978103885 +-157.62534,55.4027616,13.719616,-229438.145553288,605227.777307344,82.9364547729492,21,1.91874546694007,-0.725984919789447 +-157.56693,55.4045613,13.719616,-225734.354300744,605227.782372073,87.0423126220703,21,1.93973042125187,-0.649761576026726 +-157.50851,55.4063319,13.719616,-222030.279443764,605227.784566669,83.7846527099609,21,1.92316447383561,-0.70993382543473 +-157.45008,55.4080732,13.719616,-218325.916482298,605227.762532091,86.2287521362305,21,1.93565210123144,-0.664575198409349 +-157.39166,55.4097853,13.719616,-214622.52362019,605227.792925577,83.5988616943359,21,1.9222003640032,-0.713435747530378 +-157.33322,55.4114682,13.719616,-210918.198434608,605227.778035051,89.6720352172852,21,1.95265702671897,-0.602808455349668 +-157.27478,55.4131218,13.719616,-207214.20027389,605227.771737533,89.5718154907227,21,1.95217137682262,-0.60457247439152 +-157.21634,55.4147463,13.719616,-203510.52233886,605227.795548818,90.7029342651367,21,1.95762133683457,-0.584776664054658 +-157.15788,55.4163415,13.719616,-199805.895535965,605227.766323169,91.029296875,21,1.95918118818338,-0.579110838729853 +-157.09943,55.4179074,13.719616,-196102.210876159,605227.775282353,91.4847869873047,21,1.96134888120558,-0.571237158952051 +-157.04097,55.4194441,13.719616,-192398.197635956,605227.773241637,91.2652359008789,21,1.96030538069383,-0.575027450655438 +-156.98251,55.4209516,13.719616,-188694.482364013,605227.789604298,93.1979827880859,21,1.9694065124239,-0.541969542490204 +-156.92404,55.4224298,13.719616,-184990.427608803,605227.784716537,94.1859512329102,21,1.97398612830204,-0.525335070468274 +-156.86556,55.4238788,13.719616,-181286.027162182,605227.770721845,94.8590621948242,21,1.97707882677141,-0.51410150688351 +-156.80708,55.4252985,13.719616,-177581.908040191,605227.764259824,92.9598541259766,121,1.96829543354525,-0.546005298110918 +-156.7486,55.4266889,13.719616,-173878.064513025,605227.764697845,92.6084213256836,121,1.96665048094738,-0.551980235462614 +-156.69012,55.4280501,13.719616,-170174.490398749,605227.782546388,114.288497924805,121,2.05800252489096,-0.220163537390256 +-156.63162,55.4293821,13.719616,-166469.915505541,605227.767066751,148.028259277344,121,2.17034463212919,0.187895061728808 +-156.57313,55.4306847,13.719616,-162766.231726953,605227.772277737,160.805236816406,121,2.20630018796613,0.318495903265943 +-156.51463,55.4319581,13.719616,-159062.167967,605227.770284559,175.588806152344,121,2.24449682602781,0.45723699511188 +-156.45613,55.4332023,13.719616,-155358.350764957,605227.785587305,189.05876159668,121,2.27659680878091,0.573833294718394 +-156.39762,55.4344171,13.719616,-151654.142973969,605227.772532533,191.563674926758,220,2.28231315988604,0.594596713541288 +-156.33911,55.4356027,13.719616,-147950.1702881,605227.776793465,195.78173828125,220,2.29177218014559,0.628954574997144 +-156.2806,55.436759,13.719616,-144246.427381667,605227.786709674,202.706130981445,220,2.30686688441646,0.683782849366481 +-156.22208,55.437886,13.719616,-140542.276271571,605227.780602947,207.880020141602,220,2.31781275022984,0.72354135826183 +-156.16356,55.4389837,13.719616,-136838.343463203,605227.780248567,204.784515380859,122,2.31129711471156,0.699874710311914 +-156.10503,55.4400521,13.719616,-133133.990971781,605227.765109858,195.553100585938,122,2.29126470628502,0.627111285088098 +-156.04651,55.4410913,13.719616,-129430.477202521,605227.786496048,193.486679077148,122,2.28665107063436,0.610353243542189 +-155.98797,55.4421011,13.719616,-125725.900375937,605227.76320777,209.91862487793,122,2.32205097275519,0.738935792183061 +-155.92944,55.4430817,13.719616,-122022.150806971,605227.775530799,199.650909423828,122,2.30027129277654,0.659825777961023 +-155.8709,55.4440329,13.719616,-118317.958920055,605227.763453073,198.2138671875,221,2.29713403477256,0.648430361427977 +-155.81236,55.4449549,13.719616,-114613.95057857,605227.767751429,217.853103637695,221,2.33816375147913,0.797462003553334 +-155.75382,55.4458476,13.719616,-110910.120361477,605227.776879589,203.253570556641,221,2.30803818358677,0.688037342275139 +-155.69528,55.4467109,13.719616,-107206.462807803,605227.779303254,332.456420898438,221,2.52173472511665,1.46424417617717 +-155.63673,55.447545,13.719616,-103502.339348438,605227.781323462,695.178955078125,320,2.84209661638684,2.62789000565791 +-163.12848,55.066422,13.719616,-581318.115987171,601523.768309852,42.2707252502441,12,1.62603969920061,-1.78917581476306 +-163.07104,55.0709663,13.719616,-577614.190745378,601523.775589268,51.8113327026367,12,1.71442476345016,-1.46813603379971 +-162.15018,55.1397876,12.89140792,-518350.264207656,601523.785499661,67.0991821289062,12,1.82671722659123,-1.06025775621138 +-161.91946,55.1558468,12.38053787,-503534.417123192,601523.796290532,54.4603996276855,12,1.7360808238468,-1.3894750411841 +-161.74629,55.1675897,10.07153371,-492422.306633152,601523.78232643,39.2779235839844,12,1.59414852087017,-1.90501367710774 +-161.28399,55.1976387,13.719616,-462789.894742614,601523.740058389,56.0664176940918,12,1.74870280818714,-1.34362839138698 +-161.22616,55.2012653,13.719616,-459086.367882595,601523.797077158,23.3720016479492,13,1.36869590826014,-2.72392191668966 +-161.16831,55.204863,13.719616,-455382.272939453,601523.782600402,61.7580757141113,13,1.79069375559577,-1.19110528498919 +-161.11045,55.2084319,13.719616,-451678.236052285,601523.777494575,62.1125869750977,13,1.79317961788848,-1.18207592360633 +-161.05258,55.211972,13.719616,-447974.251774137,601523.781883835,77.6951065063477,13,1.89039366636571,-0.828966751885102 +-160.9947,55.2154832,13.719616,-444270.315826234,601523.78483023,64.7744140625,13,1.8114034931272,-1.11588160712746 +-160.93681,55.2189656,13.719616,-440566.421566589,601523.797554098,50.8982696533203,13,1.70670301823483,-1.49618361642733 +-160.8789,55.2224191,13.48374621,-436861.931889715,601523.743358005,47.9955177307129,13,1.68120068079825,-1.58881538508876 +-160.4733,55.2457852,13.719616,-410934.245155167,601523.777161318,136.487670898438,13,2.13509342278626,0.0598526076983958 +-160.41532,55.2490076,13.719616,-407230.488668702,601523.799526798,133.456314086914,13,2.12533912595594,0.0244222174571712 +-160.35732,55.2522011,8.73121984,-403526.087324312,601523.761957438,18.1523551940918,13,1.25893298096661,-3.1226121980783 +-160.29932,55.2553657,13.61438746,-399822.301219502,601523.786814122,65.2468414306641,13,1.81455949252471,-1.10441811650376 +-160.24131,55.2585013,13.719616,-396118.493087321,601523.801981376,82.1537704467773,13,1.91462750017099,-0.74094255047948 +-160.18328,55.261608,13.719616,-392414.02354905,601523.759759848,169.296768188477,13,2.22864866767002,0.399671960441663 +-160.12525,55.2646857,13.719616,-388710.153721102,601523.768111552,98.3767547607422,13,1.99289249201119,-0.456661761063169 +-160.06721,55.2677345,13.56497681,-385006.244239652,601523.778805976,24.8293113708496,13,1.39496467477054,-2.62850625887144 +-160.00916,55.2707543,13.719616,-381302.29059248,601523.781092765,89.4624328613281,13,1.95164070429811,-0.606500028469535 +-159.9511,55.2737452,13.719616,-377598.286233151,601523.786414411,68.7917861938477,13,1.83753658614768,-1.02095875414971 +-159.83495,55.2796399,12.825396,-370190.1071933,601523.763260959,57.0220413208008,13,1.75604276047416,-1.31696758964956 +-159.77686,55.2825438,13.719616,-366485.920415465,601523.7466416,78.8734664916992,13,1.89693092850364,-0.805221549879762 +-159.71877,55.2854187,13.719616,-362782.294523202,601523.778119016,91.0174713134766,112,1.95912476558195,-0.579315781722888 +-159.66066,55.2882647,13.719616,-359077.957403087,601523.759390943,115.315635681152,112,2.06188819740452,-0.206049665739659 +-159.60255,55.2910816,13.719616,-355374.171003403,601523.777385655,134.542037963867,112,2.12885800183466,0.0372037790358544 +-159.54443,55.2938694,13.719616,-351670.296928038,601523.777911068,148.869705200195,112,2.17280632835663,0.196836645064903 +-159.4863,55.2966283,13.57418387,-347966.327743231,601523.78361273,117.86254119873,112,2.07137580055252,-0.171587983074584 +-159.42816,55.2993582,13.719616,-344262.258818795,601523.783855345,143.038177490234,112,2.15545196795788,0.133800654669035 +-159.37001,55.302059,13.719616,-340558.085483707,601523.768012726,176.529251098633,112,2.24681667877862,0.465663362454722 +-159.31186,55.3047308,13.719616,-336854.434048789,601523.798393848,189.673477172852,112,2.27800660593984,0.578954080395796 +-159.25369,55.3073735,13.719616,-333150.034214829,601523.762392907,181.209335327148,112,2.25818056738403,0.506940249446302 +-159.19552,55.3099872,13.719616,-329446.145110613,601523.772510447,185.858963012695,112,2.26918350970451,0.546906076506709 +-159.13734,55.3125718,13.719616,-325742.129216057,601523.767444466,185.651962280273,112,2.26869954393649,0.545148174699669 +-159.07915,55.3151274,13.719616,-322037.98007076,601523.758834723,191.554580688477,112,2.2822925418265,0.594521822864042 +-159.02096,55.3176539,13.719616,-318334.325736255,601523.784059209,188.696197509766,112,2.27576314861663,0.570805203051427 +-158.96275,55.3201513,13.719616,-314629.894994549,601523.747252378,187.5751953125,120,2.27317540733117,0.561405788087749 +-158.90454,55.3226197,13.719616,-310925.947013707,601523.755404125,190.315292358398,120,2.279473686448,0.584282935547903 +-158.84633,55.325059,13.719616,-307222.477018164,601523.796320733,184.706741333008,120,2.26648274638934,0.5370961332714 +-158.7881,55.3274692,13.719616,-303518.213784493,601523.777520851,179.875366210938,120,2.25497169113217,0.495284694995078 +-158.72987,55.3298503,13.719616,-299814.417297158,601523.791578573,180.221221923828,120,2.25580592993797,0.498314888453206 +-158.67163,55.3322023,13.719616,-296110.449131618,601523.792856232,187.691757202148,120,2.27344520027064,0.562385753050477 +-158.61338,55.3345252,13.719616,-292406.303664029,601523.781989508,178.120132446289,120,2.25071300939132,0.479815947363522 +-158.55512,55.336819,13.719616,-288701.975268823,601523.759626765,175.91960144043,120,2.24531423242585,0.460206048460572 +-158.49686,55.3390837,13.719616,-284998.091121169,601523.769343228,171.801330566406,120,2.23502652303079,0.422838151533126 +-158.43859,55.3413193,13.719616,-281294.012789735,601523.767782836,145.563690185547,120,2.16305305685447,0.161409979108228 +-158.38032,55.3435257,13.719616,-277590.368180466,601523.786316994,142.529998779297,120,2.15390628141934,0.128186279978199 +-158.32204,55.345703,13.719616,-273886.518105157,601523.793842801,131.593490600586,120,2.11923440701225,0.00224813579342293 +-158.26375,55.3478512,13.719616,-270182.456930009,601523.791071932,127.858459472656,120,2.10672946744842,-0.0431733739674822 +-158.20545,55.3499703,13.719616,-266478.179019639,601523.778728826,122.308784484863,120,2.08745765013765,-0.113174115164526 +-158.14715,55.3520602,13.719616,-262774.312234594,601523.786002104,118.702270507812,120,2.07445902611199,-0.160388827802382 +-158.08884,55.3541209,13.719616,-259070.218104698,601523.772956339,108.842277526855,120,2.03679762082361,-0.297185801445083 +-158.03053,55.3561525,13.719616,-255366.523087507,601523.789922199,100.707786560059,21,2.00306305078531,-0.419719388629106 +-157.9722,55.358155,13.719616,-251661.955936676,601523.760212483,93.1201171875,21,1.96904351384633,-0.543288056934046 +-157.91388,55.3601283,13.719616,-247958.410072492,601523.787180291,84.5389404296875,21,1.9270568002895,-0.695795784773604 +-157.85554,55.3620724,13.719616,-244253.981413962,601523.75794073,77.5085601806641,21,1.8893496693957,-0.83275884686657 +-157.7972,55.3639874,13.719616,-240549.929254216,601523.758541627,79.693717956543,21,1.90142408846843,-0.788901110412092 +-157.73886,55.3658732,13.719616,-236846.248572681,601523.777015449,80.2790985107422,21,1.90460248695934,-0.777356259887862 +-157.68051,55.3677298,13.719616,-233142.300888928,601523.777420424,80.656135559082,21,1.90663741001512,-0.769964838524398 +-157.62215,55.3695573,13.719616,-229438.07991636,601523.771728492,82.2351379394531,21,1.91505742523477,-0.739380939935005 +-157.56379,55.3713555,13.719616,-225734.214000806,601523.772550098,82.7656707763672,21,1.9178502391531,-0.729236642635187 +-157.50542,55.3731246,13.719616,-222030.063453132,601523.767899222,83.4812469482422,21,1.92158892744057,-0.715656659647222 +-157.44705,55.3748645,13.719616,-218326.25599955,601523.78041771,85.4995727539062,21,1.93196394454005,-0.677971636217205 +-157.38867,55.3765752,13.719616,-214622.153152936,601523.777016568,87.7902221679688,21,1.94344614808188,-0.6362649956061 +-157.33029,55.3782566,13.719616,-210918.38258805,601523.779245157,87.6101989746094,21,1.94255466667683,-0.639503110523374 +-157.2719,55.3799089,13.719616,-207214.304688823,601523.777404076,85.8180541992188,21,1.93357866330639,-0.67210651677123 +-157.2135,55.381532,13.719616,-203509.914334892,601523.761309433,85.9481582641602,21,1.93423657486505,-0.669716794203537 +-157.15511,55.3831259,13.719616,-199806.47144141,601523.792086669,86.8789520263672,21,1.9389145736178,-0.652724967499744 +-157.0967,55.3846905,13.719616,-196102.072429469,601523.767643028,89.4708709716797,21,1.95168166508839,-0.606351247187869 +-157.03829,55.386226,13.719616,-192397.976163691,601523.770824446,90.2320098876953,21,1.95536063123903,-0.592988192047268 +-156.97988,55.3877322,13.719616,-188694.177979507,601523.778695825,94.1845245361328,21,1.97397954970701,-0.525358965803137 +-156.92146,55.3892092,13.719616,-184990.038860999,601523.773859548,94.089958190918,21,1.97354327555281,-0.526943638056221 +-156.86304,55.3906569,13.719616,-181286.186395226,601523.773502199,95.2103271484375,21,1.97868405742159,-0.508270850983592 +-156.80461,55.3920754,13.719616,-177581.981583652,601523.761368387,94.6777114868164,121,1.97624775178494,-0.517120208446785 +-156.74618,55.3934647,13.719616,-173878.051531147,601523.764683354,92.6448593139648,121,1.96682132615338,-0.551359676910356 +-156.68775,55.3948248,13.719616,-170174.390539117,601523.78282998,101.931274414062,121,2.00830745409069,-0.400670218922205 +-156.62931,55.3961556,13.719616,-166470.360546423,601523.779007338,134.799911499023,121,2.12968960706949,0.0402244066125373 +-156.57086,55.3974572,13.719616,-162765.955391991,601523.765426549,143.84895324707,121,2.15790670598529,0.142716963836599 +-156.51242,55.3987295,13.719616,-159062.435400363,601523.77995395,167.132537841797,121,2.22306100781993,0.379375984989203 +-156.45396,55.3999726,13.719616,-155357.896020879,601523.761300644,178.875503540039,122,2.25255086932187,0.486491579208728 +-156.39551,55.4011865,13.719616,-151654.229957315,601523.780767625,181.583160400391,122,2.25907557059317,0.510191156561254 +-156.33705,55.402371,13.719616,-147950.166684272,601523.769322341,184.443817138672,122,2.26586410153863,0.534849038594804 +-156.27859,55.4035264,13.719616,-144246.332093795,601523.783226346,190.850143432617,122,2.28069249067742,0.588709980390528 +-156.22012,55.4046524,13.719616,-140542.088823644,601523.76740664,189.390487670898,122,2.27735816233472,0.576598748137771 +-156.16165,55.4057492,13.719616,-136838.063185447,601523.765904402,192.637466430664,122,2.28474075777116,0.603414441965461 +-156.10318,55.4068168,13.719616,-133134.2494714,601523.778231922,190.5927734375,122,2.28010642979803,0.586581239998156 +-156.0447,55.4078551,13.719616,-129430.009513376,601523.773291587,197.217498779297,122,2.2949454465389,0.640480784278063 +-155.98622,55.4088641,13.719616,-125725.970374996,601523.77122536,212.742721557617,122,2.32785471074753,0.760016625122967 +-155.92774,55.4098438,13.719616,-122022.126316697,601523.771583531,206.044692993164,122,2.31396143306364,0.709552275038819 +-155.86926,55.4107943,13.719616,-118318.471284694,601523.785064002,203.796600341797,122,2.3091969349937,0.692246258125678 +-155.81077,55.4117155,13.719616,-114614.367068648,601523.782850771,373.0654296875,221,2.57178500676916,1.64604108491172 +-155.75228,55.4126074,13.719616,-110910.440729258,601523.782906979,556.522766113281,221,2.74548293505912,2.27696153878552 +-155.69378,55.41347,13.719616,-107206.053721712,601523.768692133,685.2685546875,320,2.83586080355382,2.6052397535702 +-163.17792,55.0288964,11.63700123,-585022.057038629,597819.751889659,24.3792018890381,12,1.38701948385577,-2.65736546005714 +-163.12054,55.0334656,13.71733254,-581317.978124734,597819.748911463,64.2444458007812,12,1.80783558706419,-1.12884126033006 +-163.06315,55.0380062,13.719616,-577614.135337873,597819.768295152,84.0660705566406,12,1.92462074795896,-0.704644222156693 +-163.00575,55.0425183,13.06164441,-573910.521882433,597819.820805682,32.9878997802734,12,1.51835466647372,-2.18031858999552 +-162.54602,55.0775873,13.719616,-544278.49631128,597819.813835205,26.9609851837158,12,1.43073575774585,-2.49857547542152 +-162.20067,55.102688,9.874100887,-522053.923564314,597819.739302446,18.6818218231201,12,1.27141922570286,-3.07725859326718 +-162.14307,55.1067712,11.26648854,-518349.968146526,597819.744060253,23.7784538269043,12,1.37618361158315,-2.69672444101718 +-161.91255,55.1228173,11.59784818,-503534.29372177,597819.78342489,34.4019927978516,12,1.53658360059604,-2.11410589820742 +-161.27763,55.1645749,13.719616,-462790.08742788,597819.764593825,53,13,1.72427586960079,-1.43235400447501 +-161.21984,55.1681985,13.719616,-459085.945422768,597819.752210257,64.9881286621094,13,1.81283403160593,-1.11068548305637 +-161.16205,55.1717932,13.719616,-455382.500013592,597819.803810841,71.9763488769531,13,1.85718981254739,-0.949572626276668 +-161.10424,55.1753592,13.719616,-451678.476631384,597819.803952259,57.6012420654297,13,1.76043184829034,-1.30102516993082 +-161.04642,55.1788964,13.719616,-447974.504399962,597819.81082022,123.853713989258,13,2.09290903426345,-0.0933731320396694 +-160.98858,55.1824047,13.719616,-444269.945681781,597819.746583112,66.5565338134766,13,1.82319069632236,-1.07306712071988 +-160.93074,55.1858842,13.719616,-440566.060558714,597819.756815548,49.201774597168,13,1.69198076707343,-1.54965903479435 +-160.87289,55.1893349,13.63303783,-436862.210218599,597819.774226109,47.0134963989258,13,1.67222255091798,-1.62142651542732 +-160.46764,55.2126818,13.44649862,-410934.523883554,597819.812266448,72.6178588867188,13,1.8610434397381,-0.935575152385278 +-160.4097,55.2159015,13.719616,-407230.128167295,597819.767711296,100.682472229004,13,2.00295387098273,-0.420115960835094 +-160.35176,55.2190924,13.719616,-403526.351301604,597819.794215576,151.793579101562,13,2.18125340120546,0.227518824686491 +-160.2938,55.2222543,13.719616,-399821.923197957,597819.747810642,63.1045761108398,13,1.80006085381824,-1.15708131060918 +-160.23584,55.2253873,13.719616,-396118.103996482,597819.760840854,124.266235351562,13,2.09435314157418,-0.0881277220978352 +-160.17787,55.2284915,13.719616,-392414.253793269,597819.783938796,220.144760131836,13,2.34270835287566,0.813969292983914 +-160.11989,55.2315667,13.719616,-388710.369155307,597819.795248353,96.3413543701172,13,1.98381274734829,-0.489641985295973 +-160.0619,55.2346129,13.719616,-385006.444539797,597819.795097759,71.5214614868164,13,1.85443638035686,-0.959573877900453 +-160.0039,55.2376302,13.719616,-381302.473396321,597819.794918363,67.8850402832031,13,1.83177408004985,-1.04188982108001 +-159.94589,55.2406186,11.11166468,-377598.450206725,597819.795065881,30.2185287475586,13,1.48027331598014,-2.31864092448777 +-159.82984,55.2465085,11.2790195,-370190.227558482,597819.775639195,47.0560150146484,13,1.67261514573784,-1.62000049898386 +-159.7718,55.24941,13.719616,-366486.017014063,597819.75683448,72.6350936889648,13,1.8611465010448,-0.935200804302715 +-159.71376,55.2522826,13.719616,-362782.365650925,597819.794526088,128.444961547852,112,2.10871707306416,-0.0359538230519906 +-159.6557,55.2551261,13.719616,-359078.003114538,597819.757127894,104.951774597168,112,2.02098978633187,-0.354604368324231 +-159.59764,55.2579407,13.719616,-355374.188661099,597819.775954359,98.1452560424805,112,1.991869312348,-0.460378241644456 +-159.53957,55.2607263,13.44480822,-351670.284325464,597819.785723089,57.7892265319824,13,1.76184688178011,-1.29588536440521 +-159.48149,55.2634829,13.36756179,-347966.284543671,597819.786886152,65.839973449707,13,1.81848964707286,-1.09014267340709 +-159.4234,55.2662104,13.719616,-344262.184658197,597819.768808538,81.6011047363281,13,1.91169603838185,-0.751590456420167 +-159.3653,55.268909,13.719616,-340557.977274465,597819.754165524,119.977874755859,112,2.07910116473615,-0.143527255321177 +-159.3072,55.2715786,13.719616,-336854.291100863,597819.783070445,172.138412475586,112,2.235877793423,0.425930208574376 +-159.24909,55.2742191,13.719616,-333150.488084698,597819.793085116,183.83088684082,112,2.26441848233614,0.52959813703056 +-159.19096,55.2768307,13.719616,-329445.927523646,597819.757320087,185.985214233398,112,2.26947841931422,0.547977272384749 +-159.13284,55.2794132,13.719616,-325742.505671412,597819.80291879,193.544784545898,112,2.28678147287298,0.610826901693357 +-159.0747,55.2819666,13.719616,-322038.316840808,597819.781596857,196.719863891602,112,2.29384821524699,0.636495327044861 +-159.01655,55.284491,13.719616,-318333.987942906,597819.754616274,197.203979492188,112,2.29491567457101,0.64037264399292 +-158.9584,55.2869864,13.719616,-314630.14675657,597819.769917682,196.487152099609,120,2.29333415799559,0.634628124381227 +-158.90024,55.2894527,13.719616,-310926.155159544,597819.768479705,195.128204345703,120,2.29032004800247,0.623680016573552 +-158.84207,55.29189,13.719616,-307222.006726444,597819.761997139,196.380126953125,120,2.29309753644847,0.633768647383543 +-158.7839,55.2942982,13.719616,-303518.330032283,597819.785666823,187.478942871094,120,2.27295249601872,0.560596110575726 +-158.72572,55.2966773,13.719616,-299814.486099261,597819.793282793,184.38215637207,120,2.26571888979728,0.53432158810266 +-158.66753,55.2990274,13.719616,-296110.468525876,597819.796579826,186.70817565918,120,2.271163335442,0.554097368683784 +-158.60933,55.3013484,13.719616,-292406.272492569,597819.78508736,185.079040527344,120,2.26735723939734,0.540272541481626 +-158.55113,55.3036403,13.719616,-288702.525736664,597819.802927746,183.66096496582,120,2.26401686179645,0.528139336596507 +-158.49291,55.3059031,13.719616,-284997.955913344,597819.76326212,185.562515258789,120,2.26849025065212,0.544387961752581 +-158.4347,55.3081368,13.719616,-281294.457476885,597819.795508917,163.278228759766,120,2.21292828051232,0.342571027239682 +-158.37647,55.3103414,13.719616,-277590.124719004,597819.771613568,144.043380737305,120,2.15849330582842,0.144847661899104 +-158.31824,55.3125169,13.719616,-273886.218730558,597819.776432313,130.592742919922,120,2.11591904372771,-0.00979420995490825 +-158.26,55.3146633,13.719616,-270182.100520342,597819.768322182,125.845001220703,120,2.09983596930527,-0.0682125268236724 +-158.20176,55.3167806,13.719616,-266478.397815879,597819.788135024,123.575340270996,120,2.09193181498645,-0.0969226713798986 +-158.14351,55.3188688,13.719616,-262774.471622821,597819.7953687,117.744781494141,120,2.07094166808526,-0.173164876109416 +-158.08525,55.3209278,13.719616,-259070.31699013,597819.779658344,107.647911071777,120,2.03200560667411,-0.314591764613047 +-158.02698,55.3229578,13.719616,-255365.926901422,597819.764000647,95.6379699707031,21,1.98063034912631,-0.501201363985087 +-157.96871,55.3249586,13.719616,-251661.930437727,597819.764833658,86.542724609375,21,1.93723056389472,-0.658841771478233 +-157.91044,55.3269302,13.719616,-247958.321929566,597819.781272069,81.6134033203125,21,1.91176148853371,-0.751352722787246 +-157.85216,55.3288727,13.719616,-244254.461700151,597819.786783149,83.268684387207,21,1.92048170302878,-0.719678414744151 +-157.79387,55.3307861,13.719616,-240550.344106365,597819.782182129,76.4624862670898,21,1.88344841550517,-0.854193885382526 +-157.73557,55.3326703,13.719616,-236845.964129833,597819.757176866,77.0142135620117,21,1.88657088493728,-0.842852185163596 +-157.67727,55.3345254,13.719616,-233141.948839101,597819.758832955,81.2859420776367,21,1.91001544342906,-0.757694856978225 +-157.61897,55.3363513,13.719616,-229438.293193506,597819.775209398,81.1955795288086,21,1.90953238590985,-0.759449459766356 +-157.56066,55.3381481,13.719616,-225734.357558082,597819.782628905,84.1773071289062,21,1.92519502835234,-0.702558271852006 +-157.50234,55.3399157,13.719616,-222030.136869954,597819.770848125,86.9120254516602,21,1.9390798711089,-0.652124559831497 +-157.44402,55.3416541,13.719616,-218326.258808687,597819.77363218,87.0914001464844,21,1.93997527265036,-0.648872205859856 +-157.38569,55.3433634,13.719616,-214622.083764673,597819.769017056,87.8482131958008,21,1.94373293251207,-0.635223312699228 +-157.32736,55.3450435,13.719616,-210918.240002022,597819.778555646,88.0905914306641,21,1.94492952580199,-0.630876944328505 +-157.26902,55.3466944,13.719616,-207214.088476179,597819.770301608,85.1207122802734,21,1.93003524909216,-0.684977208588418 +-157.21068,55.3483161,13.719616,-203510.256861666,597819.77584043,86.1736145019531,21,1.93537430955613,-0.665584217063729 +-157.15233,55.3499087,13.719616,-199806.105582998,597819.775492374,88.6226501464844,21,1.94754473290825,-0.621377765664152 +-157.09398,55.351472,13.719616,-196102.263379055,597819.777502696,90.9119262695312,21,1.95862085982588,-0.581146111257953 +-157.03562,55.3530062,13.719616,-192398.09015329,597819.774458812,92.1148986816406,21,1.96432987875204,-0.560409325001906 +-156.97726,55.3545111,13.719616,-188694.214603175,597819.773514259,90.7764511108398,21,1.95797320007343,-0.583498596339353 +-156.91889,55.3559869,13.719616,-184989.996668992,597819.76839956,93.2106246948242,21,1.96946541861304,-0.541755578397718 +-156.86052,55.3574334,13.719616,-181286.065006886,597819.765176661,96.1567916870117,21,1.98297996447697,-0.492666890384507 +-156.80215,55.3588508,13.719616,-177582.412954226,597819.785459002,98.6751556396484,121,1.99420782007781,-0.451884114093208 +-156.74377,55.3602389,13.719616,-173878.402405588,597819.78017957,99.2210388183594,121,1.99660376967376,-0.443181341288638 +-156.68538,55.3615979,13.719616,-170174.026735371,597819.772652537,102.489936828613,122,2.01068122544686,-0.392048003814813 +-156.62699,55.3629276,13.719616,-166469.914517281,597819.766756939,129.197891235352,122,2.11125542517358,-0.0267338036727574 +-156.5686,55.3642281,13.719616,-162766.059593527,597819.773031284,139.021408081055,122,2.14308168295606,0.0888682487115802 +-156.51021,55.3654994,13.719616,-159062.456265389,597819.790898351,149.584838867188,122,2.17488757795365,0.204396337649084 +-156.45181,55.3667414,13.719616,-155358.465884163,597819.78526966,161.098175048828,122,2.2070906206755,0.321366980478334 +-156.3934,55.3679542,13.719616,-151654.082318558,597819.768396939,173.227630615234,122,2.23861716520248,0.435880388772003 +-156.33499,55.3691378,13.719616,-147949.93322721,597819.763692876,174.136611938477,122,2.24089009042361,0.444136301932588 +-156.27658,55.3702922,13.719616,-144246.012907727,597819.770631893,182.906204223633,122,2.26222843710238,0.521643267640419 +-156.21817,55.3714173,13.719616,-140542.316028807,597819.777569208,189.208038330078,122,2.2769395830607,0.575078348740116 +-156.15975,55.3725132,13.719616,-136838.203134647,597819.774531838,197.643081665039,122,2.29588161682074,0.643881221951286 +-156.10133,55.3735799,13.719616,-133134.301880469,597819.782753246,200.559280395508,122,2.30224276270913,0.666986719469733 +-156.0429,55.3746173,13.719616,-129429.973542974,597819.771137206,206.941482543945,221,2.31584755607967,0.71640321218617 +-155.98448,55.3756254,13.719616,-125726.479106573,597819.778758165,210.656890869141,221,2.3235756700496,0.744473927948288 +-155.92604,55.3766044,13.719616,-122021.912108174,597819.770640236,211.310394287109,221,2.32492086037701,0.749360043172968 +-155.86761,55.377554,13.719616,-118318.167889201,597819.769741774,274.751220703125,221,2.43893963064404,1.16350876097991 +-155.80917,55.3784745,13.719616,-114613.973051656,597819.772852251,453.206085205078,320,2.6562957325092,1.9530081625622 +-155.75073,55.3793656,13.719616,-110909.956156473,597819.76453343,685.249755859375,320,2.83584888948123,2.60519647825792 +-163.05528,55.0050439,13.42596016,-577614.4847386,594115.810543013,84.1670608520508,12,1.92514216170099,-0.702750298619332 +-162.99792,55.0095524,13.68104776,-573910.32200813,594115.796404087,84.502685546875,12,1.92687051131248,-0.696472439510328 +-162.53858,55.0445928,13.719616,-544278.267561558,594115.788113045,55.225456237793,12,1.74213931242464,-1.36746888140458 +-162.4811,55.0488443,11.03555538,-540574.021799123,594115.752459007,27.7433452606201,12,1.44315882662314,-2.45345134336234 +-162.13598,55.0737528,13.719616,-518350.158194664,594115.766394518,47.8663940429688,12,1.68003071166354,-1.59306504692849 +-162.07842,55.0778041,10.16807346,-514646.40014859,594115.804253493,20.2713203430176,12,1.30688203675477,-2.94844754143262 +-162.02084,55.0818266,9.527057402,-510942.149766579,594115.765165901,12.4181747436523,12,1.09405776677345,-3.7214860360992 +-161.96325,55.0858206,12.57522917,-507238.031571791,594115.760284387,53.6220054626465,12,1.72934305256133,-1.41394854964431 +-161.90565,55.0897858,9.99629518,-503534.044215158,594115.756405961,41.8973426818848,12,1.62218647892832,-1.80317181061056 +-161.84804,55.0937224,12.27323953,-499830.179666497,594115.775606106,29.6370239257812,12,1.47183459075455,-2.34929278315909 +-161.61747,55.1091817,10.85172091,-485013.954772176,594115.742242882,11.9435396194458,12,1.0771330545472,-3.78296142169877 +-161.32901,55.1278598,13.719616,-466494.397478637,594115.802347764,48.0024528503418,13,1.68126342971207,-1.58858746312344 +-161.27128,55.1315091,13.719616,-462790.213808958,594115.775004633,50.4541320800781,13,1.70289673977194,-1.51000910622455 +-161.21354,55.1351297,13.719616,-459086.094905662,594115.762326177,53.9286079406738,13,1.73181920998802,-1.40495443910488 +-161.15579,55.1387215,13.719616,-455382.036558076,594115.753351694,52.9791107177734,13,1.72410466416119,-1.43297587149853 +-161.09803,55.1422846,13.719616,-451678.032138871,594115.759270378,47.4172096252441,13,1.67593599333649,-1.60793823264128 +-161.04026,55.1458188,13.719616,-447974.078591249,594115.758071059,132.22900390625,13,2.12132672636649,0.00984803689543347 +-160.98248,55.1493243,13.719616,-444270.168104646,594115.772039238,98.0835113525391,13,1.99159600503053,-0.461370971831174 +-160.92469,55.152801,13.719616,-440566.29641981,594115.790257909,74.807258605957,13,1.87394373983732,-0.888717580312682 +-160.86689,55.1562488,13.719616,-436862.459236508,594115.801817826,64.8852157592773,13,1.81214575310859,-1.11318550701294 +-160.75125,55.163058,12.52034095,-429454.229140474,594115.774240586,34.6752510070801,13,1.54001961352601,-2.10162531851007 +-160.69342,55.1664194,12.42155412,-425750.459234333,594115.800720158,39.1823234558105,13,1.59309018546471,-1.90885785337937 +-160.46198,55.1795764,11.26982298,-410934.178740653,594115.770719743,12.2545976638794,13,1.08829905730777,-3.74240331257788 +-160.4041,55.1827935,13.719616,-407230.414905165,594115.793448632,80.9600296020508,13,1.90827065829025,-0.764032414613653 +-160.3462,55.1859817,13.719616,-403526.002335135,594115.750780659,192.400100708008,13,2.28420529502467,0.601469488433913 +-160.2883,55.1891411,13.719616,-399822.202311298,594115.776167605,133.946044921875,13,2.12692989454771,0.0302003430330388 +-160.23039,55.1922715,13.719616,-396118.37752654,594115.786416586,213.499130249023,13,2.32939611013941,0.765615427673463 +-160.17247,55.1953731,13.719616,-392414.520378143,594115.804008813,71.0265731811523,13,1.85142086177304,-0.970527102111588 +-160.11453,55.1984458,13.719616,-388709.992492036,594115.759649159,87.4015579223633,13,1.94151917395083,-0.643264315663259 +-159.99864,55.2045044,11.81092046,-381302.073053618,594115.769101068,82.1813278198242,13,1.91477315396362,-0.740413494330925 +-159.82474,55.2133753,13.719616,-370190.416180334,594115.794365609,63.2421188354492,13,1.80100641191053,-1.15364677372883 +-159.76675,55.2162744,13.719616,-366486.187364989,594115.773256015,80.6868591308594,13,1.9068028101662,-0.76936405796578 +-159.70876,55.2191446,13.719616,-362782.51698519,594115.805942634,89.7202835083008,13,1.95289063724593,-0.601959915236684 +-159.65075,55.2219858,13.719616,-359078.132625396,594115.771938329,68.3896636962891,13,1.83499046811079,-1.03020698159412 +-159.59274,55.224798,12.94311858,-355374.296564129,594115.780368578,50.8566055297852,13,1.70634736942835,-1.49747543440472 +-159.53472,55.2275813,8.449374523,-351670.368397174,594115.788146058,27.5687808990479,13,1.44041756187935,-2.46340839934663 +-159.47669,55.2303356,13.69688585,-347966.343509596,594115.784629505,60.8362197875977,13,1.78416222023316,-1.21482968571199 +-159.41865,55.233061,13.719616,-344262.215430445,594115.781384891,76.4389038085938,13,1.88331445031793,-0.854680485180073 +-159.3606,55.2357573,13.719616,-340557.980419341,594115.756694159,89.1515808105469,13,1.95012904836623,-0.611990794283684 +-159.30255,55.2384247,13.719616,-336854.265021365,594115.783970668,112.496215820312,112,2.05113791377184,-0.245097764329967 +-159.24449,55.241063,13.719616,-333150.431535553,594115.789679859,147.333877563477,112,2.16830261885372,0.180477886663662 +-159.18642,55.2436724,13.719616,-329446.472624027,594115.796540727,185.846420288086,112,2.26915420027649,0.546799616298403 +-159.12834,55.2462528,13.719616,-325742.383601975,594115.793981618,196.920791625977,112,2.29429157297774,0.638105728869808 +-159.07025,55.2488041,13.719616,-322038.159743883,594115.771440206,195.716156005859,112,2.29162667734215,0.628426067284426 +-159.01216,55.2513264,13.719616,-318334.428522049,594115.78850691,198.007293701172,112,2.29668118801825,0.646785492760996 +-158.95405,55.2538197,13.719616,-314629.916522068,594115.749322781,200.256698608398,120,2.30158705219701,0.664604991731298 +-158.89595,55.256284,13.719616,-310926.519917183,594115.796595519,201.846466064453,120,2.30502115016871,0.677078615753666 +-158.83783,55.2587193,13.719616,-307222.331371481,594115.78878821,205.904037475586,120,2.31366486257809,0.708475046385678 +-158.7797,55.2611255,13.719616,-303517.980019674,594115.762773487,198.116928100586,120,2.29692158541527,0.647658684723207 +-158.72157,55.2635026,13.719616,-299814.094164721,594115.764311081,193.041107177734,120,2.28564979978242,0.606716342016781 +-158.66343,55.2658507,13.719616,-296110.033490671,594115.758876642,191.329559326172,120,2.28178207123241,0.592667647963493 +-158.60529,55.2681698,13.719616,-292406.426326193,594115.791141783,191.411102294922,120,2.2819671242746,0.593339813432134 +-158.54713,55.2704598,13.719616,-288702.000006512,594115.762033043,190.935928344727,120,2.28088765711926,0.589418880613343 +-158.48897,55.2727207,13.719616,-284998.01674563,594115.759717079,187.298736572266,120,2.27253484784217,0.559079093189816 +-158.43081,55.2749526,13.719616,-281294.470177639,594115.794310252,187.551696777344,120,2.27312099756008,0.561208156269047 +-158.37263,55.2771554,13.719616,-277590.087603601,594115.770121224,140.023818969727,120,2.14620191830137,0.100201834089556 +-158.31445,55.2793291,13.719616,-273886.131232604,594115.772008123,127.22208404541,120,2.10456250554651,-0.0510443981077484 +-158.25626,55.2814737,13.719616,-270181.961518456,594115.758329851,124.175148010254,120,2.09403468632378,-0.0892844424634647 +-158.19807,55.2835893,13.719616,-266478.206045636,594115.781054757,120.097946166992,120,2.07953558045895,-0.141949333421353 +-158.13987,55.2856757,13.719616,-262774.226681623,594115.777453776,110.008865356445,120,2.04142768534224,-0.280368085561412 +-158.08166,55.287733,13.719616,-259070.017080171,594115.759394394,103.674850463867,120,2.01567341762888,-0.373914936896208 +-158.02345,55.2897613,13.719616,-255366.204850367,594115.777211708,86.6370010375977,21,1.93770341066061,-0.657124257060603 +-157.96523,55.2917604,13.719616,-251662.151796708,594115.769884031,75.0550003051758,21,1.87537963105772,-0.883502013556055 +-157.90701,55.2937305,13.719616,-247958.484860744,594115.797773611,80.3505172729492,21,1.90498867696824,-0.775953507545926 +-157.84877,55.2956714,13.719616,-244253.931887179,594115.764217985,80.5441360473633,21,1.90603392743712,-0.772156859498788 +-157.79054,55.2975832,13.719616,-240550.388324775,594115.791488739,77.9785766601562,21,1.89197530376449,-0.823221793408465 +-157.73229,55.2994658,13.719616,-236845.94740368,594115.758958428,77.2148971557617,21,1.88770109733567,-0.838746931137907 +-157.67405,55.3013194,13.719616,-233142.503973516,594115.796699066,79.2870025634766,21,1.89920199970598,-0.796972371044595 +-157.61579,55.3031438,13.719616,-229438.151877503,594115.776334869,82.9058151245117,21,1.91858499361318,-0.726567804716382 +-157.55753,55.304939,13.719616,-225734.1532763,594115.768386104,84.6473541259766,21,1.92761338764936,-0.693774100616748 +-157.49927,55.3067052,13.719616,-222030.501320314,594115.79430222,88.526237487793,21,1.94707200637467,-0.623094843363701 +-157.44099,55.3084422,13.719616,-218325.923708161,594115.765310128,87.1831970214844,21,1.94043279062032,-0.647210370004349 +-157.38272,55.31015,13.719616,-214622.316514457,594115.78093924,87.3395843505859,21,1.94121112078115,-0.644383252702659 +-157.32444,55.3118287,13.719616,-210918.405665803,594115.78636488,88.6501998901367,21,1.9476797191934,-0.620887456947558 +-157.26615,55.3134782,13.719616,-207214.186057436,594115.77139468,87.3675308227539,21,1.94135006187399,-0.643878578995722 +-157.20786,55.3150986,13.719616,-203510.285386685,594115.778740031,88.6432418823242,21,1.94764563079882,-0.621011275726459 +-157.14956,55.3166898,13.719616,-199806.064608945,594115.766473659,90.5375823974609,21,1.95682889345656,-0.587655044589447 +-157.09126,55.3182519,13.719616,-196102.151438686,594115.776218091,92.4075164794922,21,1.96570729841492,-0.555406143631611 +-157.03295,55.3197848,13.719616,-192397.906809431,594115.767186182,94.2442855834961,21,1.97425502662539,-0.524358355006642 +-156.97464,55.3212885,13.719616,-188693.958951583,594115.768785131,92.1123199462891,21,1.96431772060796,-0.560453486851476 +-156.91633,55.322763,13.719616,-184990.302176531,594115.780348794,89.9049835205078,21,1.95378376576516,-0.598715817530568 +-156.85801,55.3242084,13.719616,-181286.29639751,594115.785053538,93.2013626098633,21,1.96942226181341,-0.541912336212168 +-156.79968,55.3256245,13.719616,-177581.936891823,594115.761677962,94.5159225463867,21,1.9755049777318,-0.519818175816597 +-156.74136,55.3270115,13.719616,-173878.484854859,594115.785886911,97.5783309936523,122,1.98935338554868,-0.469516805896569 +-156.68302,55.3283693,13.719616,-170174.033319228,594115.767391986,101.523994445801,122,2.00656869667178,-0.406985882158493 +-156.62469,55.3296979,13.719616,-166470.478344707,594115.784137645,128.49723815918,122,2.10889379330842,-0.0353119246838815 +-156.56634,55.3309973,13.719616,-162765.912482737,594115.760334979,140.289978027344,122,2.14702664720167,0.103197484856537 +-156.508,55.3322676,13.719616,-159062.231370627,594115.78173755,146.35710144043,122,2.1654137998246,0.169984871398868 +-156.44965,55.3335086,13.719616,-155358.162326587,594115.777062882,155.947280883789,122,2.19297780674651,0.270105212090088 +-156.3913,55.3347204,13.719616,-151654.333140485,594115.781398944,162.547058105469,122,2.2109791137268,0.335491097127086 +-156.33294,55.335903,13.719616,-147950.104195792,594115.771930321,172.400085449219,122,2.23653747674458,0.428326366690742 +-156.27458,55.3370564,13.719616,-144246.103710867,594115.771525921,185.946899414062,122,2.26938894107848,0.547652261892921 +-156.21622,55.3381806,13.719616,-140542.325985327,594115.779674087,196.301422119141,122,2.29292344588762,0.633136300776151 +-156.15785,55.3392756,13.719616,-136838.131400045,594115.775271372,214.88542175293,221,2.33220695310421,0.775825211616093 +-156.09948,55.3403414,13.719616,-133134.14817086,594115.779552178,228.432250976562,221,2.35875741933024,0.872264083206577 +-156.04111,55.3413779,13.719616,-129430.370937183,594115.780910982,241.501892089844,221,2.38292053765879,0.960031425816472 +-155.98273,55.3423852,13.719616,-125726.159715661,594115.771088281,232.794982910156,320,2.36697361636482,0.902107655972272 +-155.92435,55.3433633,13.719616,-122022.142719797,594115.769684068,256.992767333984,320,2.40992090095332,1.05810445197313 +-155.86597,55.3443122,13.719616,-118318.314244472,594115.776264229,352.781127929688,320,2.54750534444386,1.55785042124065 +-155.80758,55.3452319,13.719616,-114614.034665955,594115.773149314,525.039733886719,320,2.72019217112934,2.18509826548985 +-155.74919,55.3461223,13.719616,-110909.932488943,594115.767170766,699.592041015625,420,2.84484486003669,2.637872411021 +-162.9901,54.9765843,13.719616,-573909.89992835,590411.73564344,90.9326171875,12,1.95871969096337,-0.580787128357374 +-162.53116,55.0115961,13.719616,-544278.493065795,590411.808593195,48.2462387084961,12,1.68346346126908,-1.58059632055687 +-162.47373,55.0158442,13.719616,-540574.317384047,590411.789451728,64.3209457397461,12,1.80835242141411,-1.12696397045195 +-162.41629,55.0200637,13.4473767,-536870.316307257,590411.789125503,105.513008117676,12,2.02330600470929,-0.346191202062911 +-162.35884,55.0242546,13.51355802,-533166.484516012,590411.807482794,50.7073974609375,12,1.70507132111071,-1.50211040611485 +-162.30137,55.028417,9.995268535,-529462.180824378,590411.775724445,19.1676006317139,12,1.28256775202131,-3.03676396357235 +-162.1864,55.0366559,12.52311517,-522054.045453147,590411.759781409,22.6050224304199,12,1.35420494231049,-2.77655724115223 +-162.1289,55.0407324,13.719616,-518350.203095357,590411.775412293,79.114860534668,12,1.8982580668357,-0.800401004654723 +-162.07139,55.0447803,13.719616,-514646.503382639,590411.810358335,55.1728439331055,12,1.74172537062843,-1.36897243615918 +-162.01386,55.0487996,13.719616,-510942.306502708,590411.787621477,67.5534133911133,12,1.82964729827992,-1.04961489951236 +-161.95632,55.0527903,10.91400973,-507238.241591737,590411.785203539,12.462366104126,12,1.09560050527746,-3.71588236951126 +-161.89877,55.0567523,13.719616,-503534.304628525,590411.792011619,38.7105598449707,12,1.58782945227538,-1.92796633788576 +-161.84121,55.0606856,13.719616,-499830.490239322,590411.808015596,44.7312316894531,12,1.65061085678138,-1.69992635712307 +-161.78363,55.0645903,9.808922762,-496126.157270105,590411.769548771,27.8988780975342,12,1.44558673926476,-2.44463247165272 +-161.66845,55.0723137,11.77589505,-488718.454654807,590411.808136394,29.4793548583984,12,1.4695179749637,-2.35770739293946 +-161.61084,55.0761323,9.622171976,-485014.441058739,590411.800007387,22.5982875823975,12,1.35407553110793,-2.77702729957757 +-161.32262,55.094795,13.719616,-466494.429086275,590411.797107873,59.344970703125,13,1.77338391977873,-1.2539795493957 +-161.26494,55.0984414,13.719616,-462790.274230281,590411.783303261,80.4284362792969,13,1.90540962506367,-0.774424503912778 +-161.20725,55.102059,13.719616,-459086.183883848,590411.770309474,83.7732467651367,13,1.9231053475405,-0.710148589014874 +-161.14955,55.1056479,13.719616,-455382.151416125,590411.769305149,63.3107681274414,13,1.80147758269673,-1.15193534694782 +-161.09184,55.109208,13.719616,-451678.172605609,590411.769343857,115.219177246094,13,2.06152476970359,-0.207369738882041 +-161.03412,55.1127394,13.719616,-447974.2408356,590411.781630406,104.806785583496,13,2.02038940140791,-0.356785137734993 +-160.97639,55.116242,13.719616,-444270.351860335,590411.795240196,89.4006881713867,13,1.95134086183714,-0.607589141871334 +-160.91865,55.1197158,13.719616,-440566.500235226,590411.810330254,60.2978096008301,13,1.78030153609453,-1.22885279245244 +-160.86089,55.1231608,13.719616,-436862.046037574,590411.761288124,75,13,1.8750612633917,-0.8846584157902 +-160.74536,55.1299644,13.719616,-429454.480502265,590411.801567275,72.3919830322266,13,1.85969047341195,-0.940489512256903 +-160.68757,55.133323,13.719616,-425750.089307024,590411.760839457,59.6225624084473,13,1.77541063684145,-1.24661793454127 +-160.62978,55.1366528,13.16567305,-422046.342677884,590411.787224211,50.4749526977539,13,1.70307592061986,-1.50935827024163 +-160.57197,55.1399538,12.47611885,-418341.96620444,590411.753292112,27.9250812530518,13,1.44599444544747,-2.44315156642616 +-160.45634,55.1464692,13.719616,-410934.476416064,590411.799371401,58.2217063903809,13,1.76508492980541,-1.28412384974639 +-160.3985,55.1496837,13.719616,-407230.082110154,590411.766111416,71.6912307739258,13,1.85546603628974,-0.955833873659185 +-160.34066,55.1528693,13.719616,-403526.306093473,590411.787358075,168.007553100586,13,2.22532880670306,0.387613277826994 +-160.28281,55.156026,13.719616,-399822.508390708,590411.801521315,103.459487915039,13,2.01477032448653,-0.377195228957676 +-160.22494,55.1591539,13.719616,-396118.047982085,590411.760340298,57.8112716674805,13,1.76201252260285,-1.2952837096584 +-160.16707,55.1622529,13.719616,-392414.189376165,590411.772893249,52.8044738769531,13,1.7226707198399,-1.43818436656192 +-160.10919,55.165323,12.33559917,-388710.292590891,590411.779299994,30.0977725982666,13,1.47853435658801,-2.3249573213484 +-160.0513,55.1683643,11.31785135,-385006.351104405,590411.790985686,58.7614364624023,13,1.76909240386549,-1.2695675601132 +-159.87757,55.1773146,10.35277141,-373894.211482308,590411.772557105,99.8566284179688,13,1.99937689834846,-0.433108546412374 +-159.81964,55.1802403,10.42321083,-370190.040171979,590411.764616265,44.3015098571777,13,1.64641852783631,-1.71515409246138 +-159.76171,55.183137,13.719616,-366486.433057871,590411.796823668,53.5579795837402,13,1.72882418536419,-1.41583322340379 +-159.70376,55.1860048,13.719616,-362782.114683028,590411.769754167,66.4649505615234,13,1.82259268604711,-1.0752392647287 +-159.64581,55.1888436,12.14455073,-359078.349420685,590411.782546161,59.6141242980957,13,1.77534916876697,-1.24684120413251 +-159.58785,55.1916536,9.090508287,-355374.495368898,590411.802639337,48.4674911499023,13,1.68545053967421,-1.57337868462079 +-159.52987,55.1944346,7.854286192,-351669.914405771,590411.755335803,17.3002796173096,13,1.23805312250875,-3.19845380370219 +-159.4719,55.1971866,13.719616,-347966.504399508,590411.79995303,57.9885482788086,13,1.76334223648758,-1.29045380929095 +-159.41391,55.1999097,13.719616,-344262.355455748,590411.78919815,71.2738800048828,13,1.85293040154767,-0.965044022784563 +-159.35591,55.2026038,13.719616,-340558.097413619,590411.765409372,85.5984878540039,13,1.93246609268577,-0.676147690824604 +-159.29791,55.205269,13.719616,-336854.358296728,590411.790903642,82.8591156005859,13,1.918340293531,-0.727456625259197 +-159.2399,55.2079052,13.719616,-333150.498969679,590411.803250648,98.5808563232422,112,1.9937925863369,-0.453392361559707 +-159.18188,55.2105124,13.719616,-329446.513864001,590411.802969258,125.802734375,112,2.09969008078388,-0.0687424355741006 +-159.12385,55.2130906,13.719616,-325742.397409326,590411.790590835,154.656143188477,112,2.18936717555076,0.256990369010399 +-159.06581,55.2156398,13.719616,-322038.144033406,590411.766659179,179.259658813477,112,2.2534825654912,0.489875765628319 +-159.00777,55.2181601,13.719616,-318334.381798856,590411.790768784,186.270477294922,112,2.27014402739265,0.550394950909054 +-158.94972,55.2206513,13.719616,-314630.472341642,590411.792231236,191.994720458984,120,2.28328928647931,0.598142283942292 +-158.89166,55.2231136,13.719616,-310926.408415885,590411.79383708,197.878005981445,120,2.29639752532456,0.645755148892101 +-158.83359,55.2255468,13.719616,-307222.186090755,590411.773969247,197.262741088867,120,2.29504506362232,0.640842621958589 +-158.77552,55.227951,13.719616,-303518.433431349,590411.790042022,198.928268432617,120,2.29869650233995,0.65410568960538 +-158.71744,55.2303262,13.719616,-299814.510378962,590411.795855735,196.526000976562,120,2.29342001696908,0.634939988679502 +-158.65935,55.2326724,13.719616,-296110.411348782,590411.792041705,196.533843994141,120,2.29343734857544,0.635002942020764 +-158.60125,55.2349895,13.719616,-292406.131525236,590411.768134307,201.173385620117,120,2.30357052487863,0.671809530650423 +-158.54315,55.2372776,13.719616,-288702.299005361,590411.779370025,202.741500854492,120,2.30694265716501,0.684058077616914 +-158.48504,55.2395367,13.719616,-284998.273723636,590411.781830324,196.449554443359,120,2.29325104814905,0.634326245696658 +-158.42692,55.2417667,13.719616,-281294.050830314,590411.765085166,193.885604858398,120,2.28754556584694,0.613602305468617 +-158.3688,55.2439677,13.719616,-277590.258446622,590411.782737626,159.642837524414,120,2.20314943841945,0.307051481598943 +-158.31067,55.2461396,13.719616,-273886.257224493,590411.781467221,134.307266235352,120,2.12809950932212,0.0344487177349974 +-158.25253,55.2482824,13.719616,-270182.041538378,590411.761991237,129.756500244141,120,2.11312912335633,-0.0199279970663114 +-158.19439,55.2503962,13.719616,-266478.239533896,590411.776279388,119.777656555176,120,2.078375811878,-0.146161943938292 +-158.13624,55.2524809,13.719616,-262774.211829084,590411.772720242,112.305252075195,120,2.0504000669822,-0.247777834472391 +-158.07808,55.2545366,13.719616,-259069.952110308,590411.763184542,100.68603515625,120,2.00296923942005,-0.420060138284139 +-158.01992,55.2565631,13.719616,-255366.090598059,590411.76466207,82.7955169677734,21,1.91800682218504,-0.728667888369947 +-157.96175,55.2585606,13.719616,-251661.985826373,590411.760597185,78.2724990844727,21,1.89360920019614,-0.817287015208231 +-157.90358,55.260529,13.719616,-247958.267319628,590411.778004401,78.4760589599609,21,1.89473718480361,-0.813189853155032 +-157.8454,55.2624683,13.719616,-244254.294966056,590411.779237243,78.5078811645508,21,1.89491325642003,-0.81255031078836 +-157.78721,55.2643785,13.719616,-240550.063128092,590411.765114253,79.3219757080078,21,1.89939352283533,-0.796276704372647 +-157.72902,55.2662596,13.719616,-236846.200642399,590411.772130336,79.7191543579102,21,1.90156268315889,-0.788397694937473 +-157.67082,55.2681116,13.719616,-233142.067392983,590411.764350305,82.1034698486328,21,1.91436151161726,-0.741908696827342 +-157.61262,55.2699345,13.719616,-229438.29221375,590411.777179001,81.9350280761719,21,1.91346960686394,-0.745148349466345 +-157.55441,55.2717283,13.719616,-225734.234985998,590411.775822127,84.4281387329102,21,1.92648721510602,-0.697864680735804 +-157.4962,55.273493,13.719616,-222030.524540958,590411.794594511,88.0716400146484,21,1.94483608357701,-0.631216353160687 +-157.43798,55.2752285,13.719616,-218326.521333585,590411.788720825,87.773551940918,21,1.94336367334951,-0.63656456737471 +-157.37975,55.276935,13.719616,-214622.218554591,590411.781351934,90.1823883056641,21,1.95512173256998,-0.593855940201726 +-157.32152,55.2786123,13.719616,-210918.246174163,590411.782923319,92.4089889526367,21,1.9657142186514,-0.555381007357486 +-157.26328,55.2802604,13.719616,-207213.964037935,590411.761491507,95.2492599487305,21,1.97886161005442,-0.50762592914261 +-157.20504,55.2818795,13.719616,-203509.999867035,590411.770892742,93.4153442382812,21,1.97041821852863,-0.538294737148153 +-157.1468,55.2834694,13.719616,-199806.349093852,590411.788164979,95.2612609863281,21,1.97891632602902,-0.507427185105353 +-157.08855,55.2850301,13.719616,-196102.371560405,590411.783076346,96.1446762084961,21,1.98292524117684,-0.492865661030179 +-157.03029,55.2865617,13.719616,-192398.061075191,590411.767734956,96.4988098144531,21,1.98452195692718,-0.487065933676879 +-156.97203,55.2880642,13.719616,-188694.046458467,590411.771550811,96.1395263671875,21,1.98290197823965,-0.492950158657954 +-156.91377,55.2895375,13.719616,-184990.322542228,590411.78273406,93.8605575561523,21,1.97248312970645,-0.530794390365977 +-156.8555,55.2909816,13.719616,-181286.249163983,590411.773335031,94.5033111572266,21,1.97544702535709,-0.520028675382799 +-156.79723,55.2923966,13.719616,-177582.45464247,590411.782254818,97.7756042480469,21,1.99023050854932,-0.466330844802423 +-156.73895,55.2937825,13.719616,-173878.298842359,590411.782686182,97.5058517456055,122,1.98903068036074,-0.470688963248401 +-156.68067,55.2951391,13.719616,-170174.411477405,590411.779058304,100.113960266113,122,2.00049464135349,-0.429048584782487 +-156.62238,55.2964667,13.719616,-166470.151032664,590411.779088023,127.391845703125,122,2.10514162988728,-0.0489408532034998 +-156.56409,55.297765,13.719616,-162766.147640025,590411.774985374,134.674896240234,122,2.12928664961758,0.0387607501316765 +-156.5058,55.2990342,13.719616,-159062.394736943,590411.78843272,144.850067138672,122,2.16091870083732,0.153657388848068 +-156.4475,55.3002741,13.719616,-155358.253003867,590411.773216306,157.772415161133,122,2.19803107371164,0.288460120053435 +-156.3892,55.3014849,13.719616,-151654.350391076,590411.775554748,167.154235839844,122,2.22311738648385,0.379580768388637 +-156.33089,55.3026666,13.719616,-147950.046756485,590411.772634799,177.511962890625,122,2.24922762636191,0.474420612230208 +-156.27258,55.303819,13.719616,-144245.971670468,590411.765065915,190.804229736328,122,2.28058799788792,0.588330432753859 +-156.21427,55.3049423,13.719616,-140542.118663655,590411.774598608,224.760131835938,221,2.35171927816393,0.846699545605051 +-156.15596,55.3060364,13.719616,-136838.482428505,590411.789604733,281.869476318359,221,2.45004804861286,1.20385770570082 +-156.09764,55.3071012,13.719616,-133134.423141939,590411.778420603,405.499481201172,320,2.60799030290818,1.77754905450901 +-156.03931,55.3081369,13.719616,-129429.93439076,590411.764510745,441.318450927734,320,2.64475208509185,1.9110783402574 +-155.98099,55.3091434,13.719616,-125726.27978698,590411.775820845,414.519226074219,420,2.61754467863611,1.8122532742432 +-155.92266,55.3101207,13.719616,-122022.184677837,590411.773483998,417.287902832031,420,2.62043579470584,1.82275463301514 +-155.86433,55.3110688,13.719616,-118318.277836721,590411.776556191,514.244995117188,420,2.71117007362186,2.15232743217969 +-155.80599,55.3119877,13.719616,-114613.919085056,590411.7673588,616.206176757812,420,2.78972604730515,2.4376651507046 +-162.98231,54.9436141,13.719616,-573910.525732514,586707.823369249,102.494316101074,12,2.01069978193437,-0.391980601355621 +-162.92503,54.9480867,11.26988403,-570206.134354692,586707.766403801,41.4667816162109,12,1.61770032953908,-1.8194667856668 +-162.52374,54.9785974,13.46499948,-544277.903112552,586707.734414865,34.9670867919922,12,1.543659451501,-2.0884043880717 +-162.46637,54.982842,13.719616,-540574.439376719,586707.802760315,53.0882339477539,12,1.72499827818534,-1.4297300103 +-162.40898,54.9870581,13.719616,-536870.512181848,586707.816136895,62.8882751464844,12,1.79856968338117,-1.16249766725903 +-162.35157,54.9912456,13.11202637,-533166.117635668,586707.765049018,58.1993980407715,12,1.76491849274399,-1.28472839665933 +-162.29416,54.9954045,12.85766763,-529462.520484866,586707.810503258,48.0535430908203,12,1.68172541464896,-1.58690940196904 +-162.23673,54.9995349,13.719616,-525758.443962591,586707.803433579,94.4066314697266,12,1.97500250181455,-0.521643311768968 +-162.17929,55.0036367,13.719616,-522054.519172646,586707.812985035,81.9026336669922,12,1.91329786718962,-0.74577215698286 +-162.12183,55.0077099,13.719616,-518350.105752989,586707.761023993,99.0307769775391,12,1.99577018645918,-0.446209153452299 +-162.06437,55.0117545,13.719616,-514646.468438836,586707.804141716,56.8753395080566,12,1.75492400212294,-1.32103123930663 +-162.00689,55.0157705,13.719616,-510942.331829108,586707.786733912,52.8114624023438,12,1.72272819370464,-1.4379756050805 +-161.9494,55.0197579,13.71373281,-507238.325620031,586707.786805671,19.9253597259521,12,1.29940617075,-2.97560202058657 +-161.8919,55.0237167,11.30849186,-503534.444471672,586707.804321981,20.8124694824219,12,1.31832361403956,-2.90688846698298 +-161.83438,55.0276468,13.719616,-499830.049318243,586707.752941008,66.2552261352539,12,1.82122014060409,-1.08022474154122 +-161.77686,55.0315483,13.719616,-496126.403551628,586707.794788224,44.7269058227539,12,1.65056885501183,-1.7000789195386 +-161.71932,55.0354212,13.719616,-492422.231756911,586707.779895386,42.0999984741211,12,1.62428208009503,-1.79555998902895 +-161.66177,55.0392654,13.719616,-488718.164898126,586707.772478606,38.4000015258789,13,1.58433124162484,-1.94067283745725 +-161.60421,55.0430809,13.54545016,-485014.197592968,586707.772558159,29.2704200744629,13,1.46642895525621,-2.36892759421106 +-161.54664,55.0468678,13.39486891,-481310.32319404,586707.791227468,30.4995517730713,13,1.48429345692344,-2.30403862511926 +-161.31624,55.0617283,13.719616,-466494.390840704,586707.790716342,64.3771896362305,13,1.80873201378921,-1.12558518259915 +-161.25861,55.0653717,13.719616,-462790.271470174,586707.779364632,54.3880081176758,13,1.73550315369764,-1.39157330404933 +-161.20097,55.0689864,13.719616,-459086.213922124,586707.777101012,62.1247215270996,13,1.79326445502887,-1.1817677708975 +-161.14332,55.0725723,13.719616,-455382.213988535,586707.772971569,88.2755355834961,13,1.94584036118559,-0.627568530236973 +-161.08566,55.0761295,13.719616,-451678.265049161,586707.778170566,114.121742248535,13,2.05736839322644,-0.222466884594975 +-161.02799,55.079658,13.719616,-447974.361695685,586707.792837217,78.6322631835938,13,1.89560077565356,-0.810053044694644 +-160.97031,55.0831577,13.719616,-444270.499683715,586707.80605025,123.958679199219,13,2.09327694011043,-0.0920367929926567 +-160.91261,55.0866287,13.719616,-440566.037380953,586707.762703822,76.1381378173828,13,1.88160225065638,-0.860899683061253 +-160.85491,55.0900708,13.719616,-436862.241732765,586707.774060257,69.9458847045898,13,1.84476216768183,-0.994713379631364 +-160.7972,55.0934843,13.719616,-433158.468817179,586707.806630274,78.5472793579102,13,1.89513114697867,-0.811758870087219 +-160.73947,55.0968689,13.719616,-429454.081592926,586707.762720103,75.8237075805664,13,1.8798050164715,-0.867427750602439 +-160.68174,55.1002248,13.719616,-425750.342409343,586707.794580037,63.5548973083496,13,1.80314902132662,-1.14586420476796 +-160.62399,55.1035518,13.719616,-422045.977991698,586707.751501504,65.7473754882812,13,1.81787842128793,-1.09236281991917 +-160.56624,55.1068501,13.719616,-418342.250723069,586707.78353212,56.2263107299805,13,1.74993958836134,-1.33913605278207 +-160.50848,55.1101195,13.719616,-414638.52231885,586707.804649491,48.8226661682129,13,1.68862149221607,-1.56186087990878 +-160.4507,55.1133602,13.719616,-410934.150095854,586707.775393178,64.8930053710938,13,1.81219788797995,-1.11299613827938 +-160.39292,55.116572,13.719616,-407230.400826406,586707.798181851,62.0901985168457,13,1.79302304838895,-1.18264462871801 +-160.33512,55.119755,13.719616,-403525.997888402,586707.761179963,199.205490112305,13,2.29930130342815,0.656302499785161 +-160.27732,55.1229091,13.719616,-399822.206931255,586707.775677292,115.107849121094,13,2.06110493886657,-0.208894684313727 +-160.21951,55.1260344,13.67096809,-396118.386380959,586707.791742028,53.4784698486328,13,1.72817897252783,-1.41817682058752 +-160.16168,55.1291309,11.33160838,-392413.895731449,586707.750602718,33.9525489807129,13,1.53087238441042,-2.13485066553701 +-160.04601,55.1352372,11.0912712,-385006.060436642,586707.761335314,62.5557174682617,13,1.7962670094961,-1.17086163605817 +-159.87243,55.1441802,6.85002453,-373893.911764535,586707.750269637,60.332706451416,13,1.78055280767264,-1.22794010236071 +-159.81456,55.1471034,9.082201713,-370190.370489776,586707.787700088,23.0923709869385,13,1.36346852597392,-2.74290926119666 +-159.75667,55.1499978,13.719616,-366486.120649394,586707.773268558,75.8767547607422,13,1.88010874789346,-0.866324511384281 +-159.69878,55.1528632,13.719616,-362782.42872888,586707.796129095,79.6189956665039,13,1.90101669498575,-0.790380879822851 +-159.64087,55.1556997,13.67814292,-359078.018166909,586707.757987218,70.9949645996094,13,1.85122754697042,-0.971229276652222 +-159.46711,55.1640358,13.68827406,-347966.134692576,586707.770273602,56.4369583129883,13,1.75156359928001,-1.3332371815866 +-159.40917,55.1667566,13.719616,-344261.970387526,586707.752420428,72.397819519043,13,1.85972548629234,-0.940362335481644 +-159.35123,55.1694485,13.719616,-340558.329853405,586707.781221042,82.2141571044922,13,1.91494660857367,-0.739783457678353 +-159.29327,55.1721115,13.719616,-336853.937490553,586707.754055796,75.100959777832,13,1.87564548725121,-0.882536347978369 +-159.23531,55.1747455,13.719616,-333150.058707765,586707.762338143,88.3900756835938,13,1.94640350576186,-0.625523028398503 +-159.17734,55.1773506,13.719616,-329446.052038656,586707.766410289,91.0821380615234,112,1.95943321668864,-0.578195399262672 +-159.11936,55.1799267,13.719616,-325741.912802116,586707.755705962,96.7271194458008,112,1.98554825458384,-0.483338127653385 +-159.06138,55.1824738,13.719616,-322038.270461945,586707.779262743,136.194122314453,112,2.13415836527515,0.0564562119260617 +-159.00339,55.184992,13.719616,-318334.483575205,586707.799135773,161.391372680664,112,2.20788031540883,0.324235377151102 +-158.94538,55.1874812,13.719616,-314629.912392808,586707.757417486,168.542984008789,120,2.2267106787218,0.392632631424598 +-158.88738,55.1899414,13.719616,-310926.456439792,586707.796819794,190.373901367188,120,2.27960741007203,0.58476865791892 +-158.82936,55.1923726,13.719616,-307222.205039196,586707.775809968,195.676834106445,120,2.29153941321417,0.62810909906392 +-158.77134,55.1947748,13.719616,-303518.422679129,586707.788075504,197.053680419922,120,2.29458455070193,0.639169907588262 +-158.71331,55.1971481,13.719616,-299814.467956196,586707.798526321,197.759155273438,120,2.29613659832747,0.644807387562707 +-158.65527,55.1994923,13.719616,-296110.33687729,586707.785581369,199.175323486328,120,2.29923553118824,0.656063596236532 +-158.59722,55.2018075,13.719616,-292406.023059237,586707.760993346,198.052474975586,120,2.29678027396335,0.647145401195558 +-158.53917,55.2040937,13.719616,-288702.155949903,586707.768892618,191.075546264648,120,2.28120510986048,0.590571959579499 +-158.48111,55.2063509,13.719616,-284998.09492874,586707.765362602,191.416320800781,120,2.28197896443109,0.593382820260015 +-158.42305,55.2085791,13.719616,-281294.469440295,586707.793443301,184.110427856445,120,2.26507838726695,0.531995100094906 +-158.36497,55.2107782,13.719616,-277590.004558774,586707.757448117,165.706298828125,120,2.21933901713572,0.365856652462261 +-158.30689,55.2129484,13.719616,-273885.963286361,586707.764463782,141.549407958984,120,2.15090805723568,0.117295873964758 +-158.24881,55.2150894,13.719616,-270182.342194433,586707.780200943,132.818115234375,120,2.12325731305748,0.0168604788014271 +-158.19072,55.2172015,13.719616,-266478.498489386,586707.796931806,120.21573638916,120,2.07996132107482,-0.140402921986051 +-158.13262,55.2192845,13.719616,-262774.427988664,586707.793175804,109.980712890625,120,2.04131653043461,-0.280771831912683 +-158.07451,55.2213384,13.719616,-259070.12506482,586707.769689925,98.0677032470703,120,1.99152600420995,-0.461625234791723 +-158.0164,55.2233633,13.719616,-255366.218449196,586707.776811789,85.8484954833984,21,1.93373268844296,-0.671547053512049 +-157.95828,55.2253591,13.719616,-251662.068170501,586707.764641404,75.3154067993164,21,1.87688382618082,-0.878038347528889 +-157.90016,55.2273259,13.719616,-247958.302976574,586707.782427401,80.1352386474609,21,1.90382353462071,-0.780185637116902 +-157.84203,55.2292636,13.719616,-244254.282873764,586707.781409311,75.9428482055664,21,1.88048688114674,-0.864951023478401 +-157.78389,55.2311722,13.719616,-240550.00222729,586707.762407334,82.0626373291016,21,1.91414547021157,-0.74269342087715 +-157.72575,55.2330518,13.719616,-236846.089809901,586707.773036653,81.0959548950195,21,1.90899919193514,-0.761386172471227 +-157.6676,55.2349022,13.719616,-233141.906209242,586707.755126992,85.5094909667969,21,1.93201432111121,-0.677788654131856 +-157.60945,55.2367236,13.719616,-229438.07958063,586707.766322596,84.4165802001953,21,1.92642775447241,-0.698080658728832 +-157.55129,55.2385159,13.719616,-225733.969874841,586707.760712107,84.9263916015625,21,1.92904267193804,-0.688582532121922 +-157.49313,55.2402791,13.719616,-222030.206483643,586707.772611863,87.5463485717773,21,1.94223803701914,-0.640653199815191 +-157.43496,55.2420132,13.719616,-218326.148730767,586707.76837,91.8593139648438,21,1.96312319764194,-0.564792335214864 +-157.37679,55.2437183,13.719616,-214622.4254394,586707.792334756,93.1656951904297,21,1.96925602896287,-0.542516141372924 +-157.31861,55.2453942,13.719616,-210918.397072477,586707.78975182,94.0998611450195,21,1.97358898257714,-0.526777617097799 +-157.26042,55.247041,13.719616,-207214.057407578,586707.772677112,97.7198944091797,21,1.98998298902658,-0.467229906358118 +-157.20223,55.2486587,13.719616,-203510.035830174,586707.772701883,99.1963348388672,21,1.99649562589751,-0.443574150351266 +-157.14404,55.2502472,13.719616,-199806.327218206,586707.777988932,100.234451293945,21,2.00101701729257,-0.427151166270837 +-157.08584,55.2518067,13.719616,-196102.289824239,586707.780556647,98.037467956543,21,1.99139208606941,-0.462111663702202 +-157.02763,55.253337,13.719616,-192397.919041156,586707.75914213,98.4747009277344,21,1.99332467051056,-0.455091965397451 +-156.96943,55.2548382,13.719616,-188694.478756117,586707.782693684,99.9303894042969,21,1.99969757975356,-0.431943740017482 +-156.91121,55.2563103,13.719616,-184990.058215353,586707.765309911,99.1058959960938,21,1.99609949224915,-0.445013020829913 +-156.85299,55.2577533,13.719616,-181285.921830846,586707.764282997,97.9010162353516,21,1.99078719990441,-0.464308782905188 +-156.79477,55.2591671,13.719616,-177582.064415296,586707.767849524,100.738410949707,21,2.00319509600336,-0.419239762707667 +-156.73655,55.2605518,13.719616,-173878.479823805,586707.786511479,101.750778198242,122,2.00753773942954,-0.403466042269941 +-156.67832,55.2619074,13.719616,-170174.527365108,586707.79403338,116.093841552734,122,2.06480918226568,-0.195439814991827 +-156.62008,55.2632338,13.719616,-166470.201819554,586707.780362129,149.980438232422,122,2.17603461824418,0.208562715382185 +-156.56184,55.264531,13.719616,-162766.132531351,586707.771093169,148.202453613281,122,2.1708553938045,0.189750293919408 +-156.5036,55.2657991,13.719616,-159062.313390639,586707.776781374,159.996368408203,122,2.20411012516732,0.310540970074498 +-156.44535,55.2670381,13.719616,-155358.103702253,586707.773473421,166.971496582031,122,2.22264233980826,0.377855263271074 +-156.3871,55.2682479,13.719616,-151654.133237062,586707.774001652,177.202301025391,122,2.24846935703264,0.471666361594683 +-156.32885,55.2694285,13.719616,-147950.396302169,586707.777830677,189.369979858398,122,2.27731113298199,0.576427924105151 +-156.27059,55.27058,13.719616,-144246.251789733,586707.773848052,211.297790527344,221,2.32489495579912,0.749265950352188 +-156.21233,55.2717024,13.719616,-140542.329067775,586707.784380876,308.618743896484,320,2.48942229931496,1.3468762227809 +-156.15406,55.2727955,13.719616,-136837.988159062,586707.766066775,459.884857177734,320,2.66264910961226,1.97608544163488 +-156.0958,55.2738595,13.719616,-133134.492701953,586707.782450575,594.255615234375,420,2.7739732941508,2.3804466549646 +-156.03752,55.2748944,13.719616,-129429.931928545,586707.7729212,658.502136230469,420,2.81855718818406,2.54238808360369 +-155.97925,55.2759,13.719616,-125726.205934104,586707.774898633,605.585388183594,420,2.78217538778034,2.41023900013768 +-163.08893,54.9016184,12.69894525,-581318.268897888,583003.787622193,41.8923187255859,12,1.62213439907828,-1.80336097949098 +-163.03173,54.9061442,13.719616,-577614.174162227,583003.766619286,82.9230499267578,12,1.91867526715557,-0.726239905443797 +-162.97452,54.9106417,13.719616,-573910.299021785,583003.79027555,113.574424743652,12,2.05528054578347,-0.230050542438845 +-162.91729,54.9151107,13.43843654,-570206.005666286,583003.750441748,77.1067276000977,12,1.88709227211234,-0.840958358125063 +-162.86005,54.9195512,11.46783887,-566501.924427426,583003.733869071,24.7551937103271,12,1.39366632905155,-2.63322222110758 +-162.8028,54.9239633,12.28595202,-562798.048571624,583003.75137795,30.9380569458008,12,1.49049303450183,-2.28151998981891 +-162.74554,54.928347,12.30079842,-559094.372861874,583003.802770898,21.5051612854004,12,1.33254270404411,-2.85524067355411 +-162.68826,54.9327021,13.719616,-555390.259371264,583003.782160377,19.2965602874756,12,1.28547990065006,-3.02618620854276 +-162.63097,54.9370288,13.719616,-551686.33550566,583003.79618331,16.0883255004883,12,1.20651084436367,-3.31302436098766 +-162.51635,54.9455966,13.70408635,-544278.405765735,583003.801371996,17.1780319213867,12,1.23497340544152,-3.20964021512913 +-162.45902,54.9498378,13.48349538,-540574.387900426,583003.804392186,42.0000762939453,12,1.62325007930289,-1.79930851046837 +-162.40167,54.9540504,12.04185606,-536869.905819339,583003.73964383,25.6514739990234,12,1.40911232583183,-2.57711795207518 +-162.22957,54.966517,10.91351489,-525758.064752399,583003.752685311,16.4618759155273,12,1.21647932378881,-3.27681599842824 +-162.17218,54.9706155,13.719616,-522054.210934043,583003.776144071,81.9333038330078,12,1.9134604674618,-0.745181546383562 +-162.11478,54.9746854,13.719616,-518350.501945031,583003.813289389,89.4716720581055,12,1.95168555357023,-0.606337123111953 +-162.05736,54.9787267,13.719616,-514646.296865056,583003.786560352,53.7125930786133,12,1.73007611928201,-1.41128584207673 +-161.99993,54.9827394,13.719616,-510942.225953192,583003.774511387,75.9437789916992,12,1.8804922040022,-0.864931689348082 +-161.94249,54.9867236,13.719616,-507238.282546425,583003.788151644,39.314323425293,12,1.59455080613251,-1.90355246221129 +-161.71261,55.002374,13.719616,-492422.424627466,583003.796118485,47.4403648376465,13,1.67614802028807,-1.60716809023466 +-161.65511,55.0062151,13.719616,-488718.411014682,583003.799174016,52.1596984863281,13,1.71733507225411,-1.45756496153895 +-161.5976,55.0100275,13.719616,-485014.495439298,583003.806907264,58.7922172546387,13,1.76931983922117,-1.26874144998486 +-161.54007,55.0138113,13.719616,-481310.035666362,583003.757939932,45.6279945373535,13,1.6592313808809,-1.66861415305109 +-161.30987,55.0286597,13.719616,-466494.284305426,583003.784114318,70.2381286621094,13,1.84657293224676,-0.988136165887861 +-161.25229,55.0323001,13.719616,-462790.205876378,583003.775196677,51.7144775390625,13,1.71361214145265,-1.47108770884011 +-161.1947,55.0359118,13.719616,-459086.187789554,583003.77257214,76.8711471557617,13,1.8857633621373,-0.845785338463074 +-161.1371,55.0394948,13.719616,-455382.22464411,583003.776359002,72.0918655395508,13,1.8578862640178,-0.947042915749074 +-161.07949,55.0430491,13.719616,-451678.311036677,583003.786687456,142.753021240234,13,2.15458530847009,0.130652700040154 +-161.02187,55.0465747,13.719616,-447974.441561376,583003.803699642,82.0826110839844,13,1.91425116308609,-0.742309514189164 +-160.96423,55.0500715,13.719616,-444269.976384078,583003.749580593,114.260475158691,13,2.05789602576662,-0.220550372607754 +-160.90659,55.0535396,13.719616,-440566.180091601,583003.769918009,93.0326690673828,13,1.96863548085818,-0.544770149211192 +-160.84894,55.056979,13.719616,-436862.411679536,583003.797435165,72.0102691650391,13,1.85739443426034,-0.948829381810381 +-160.79127,55.0603896,13.719616,-433158.031277573,583003.756023059,51.0651664733887,13,1.70812475205409,-1.49101947339253 +-160.7336,55.0637715,13.719616,-429454.30349403,583003.787962144,103.481727600098,13,2.01486367053664,-0.376856169460035 +-160.67591,55.0671246,13.719616,-425749.952843449,583003.752499314,78.4698944091797,13,1.89470306821339,-0.813313774348564 +-160.61822,55.0704489,13.719616,-422046.245056276,583003.778631922,69.584228515625,13,1.84251081655304,-1.00289092953073 +-160.56051,55.0737445,13.719616,-418341.902398092,583003.750015395,66.7501373291016,13,1.82445216353788,-1.06848511173452 +-160.5028,55.0770112,13.66330449,-414638.192800374,583003.771282682,58.2621002197266,13,1.76538613592841,-1.28302978313484 +-160.44508,55.0802492,13.719616,-410934.4730267,583003.801302017,94.1184768676758,13,1.97367489031321,-0.526465575679889 +-160.38734,55.0834584,13.719616,-407230.103122909,583003.767945736,185.382827758789,13,2.26806950243522,0.542859684135309 +-160.3296,55.0866388,13.719616,-403526.348807807,583003.794694294,147.150314331055,13,2.16776119414271,0.178511277575287 +-160.27184,55.0897903,13.719616,-399821.934483416,583003.748677458,82.6793060302734,13,1.91739682271471,-0.730883580557348 +-160.21408,55.0929131,13.48266831,-396118.12375456,583003.77333644,48.3799629211426,13,1.68466553117862,-1.5762300595405 +-159.92513,55.1080942,9.821744504,-377598.423466035,583003.79090254,73.5004730224609,13,1.8662901340554,-0.916517661069202 +-159.80948,55.1139648,13.42302607,-370190.13726614,583003.775231987,107.164291381836,13,2.03005009655743,-0.321694735514995 +-159.75165,55.1168567,11.20483276,-366486.522202124,583003.802781093,33.4492721557617,13,1.52438667211354,-2.15840862380585 +-159.6938,55.1197198,11.97140722,-362782.191205084,583003.776726862,75.7201614379883,13,1.87921153122352,-0.869583458420663 +-159.46234,55.1308832,13.719616,-347966.505492578,583003.801292603,69.3608627319336,13,1.84111448639128,-1.00796279923054 +-159.40445,55.1336018,13.719616,-344262.330425306,583003.786734463,70.9337921142578,13,1.85085317781377,-0.972589092284765 +-159.34655,55.1362915,13.719616,-340558.042848645,583003.764855379,68.9844665527344,13,1.838751310304,-1.01654652929714 +-159.28865,55.1389522,13.719616,-336854.273709188,583003.775779602,68.9182205200195,13,1.8383340553646,-1.01806211833348 +-159.23074,55.1415841,13.719616,-333150.380102406,583003.790380333,77.9520645141602,13,1.89182762170875,-0.823758216787555 +-159.17282,55.144187,13.719616,-329446.358256056,583003.786983803,81.4503479003906,13,1.91089294365861,-0.754507525681003 +-159.11489,55.146761,13.719616,-325742.201748374,583003.777227499,79.2964630126953,13,1.89925381621638,-0.796784158688906 +-159.05695,55.149306,13.719616,-322037.905888562,583003.750559417,84.686637878418,13,1.92781489139965,-0.693042181480816 +-158.99901,55.1518221,13.719616,-318334.099861618,583003.766577332,93.6104354858398,120,1.97132426563227,-0.53500371545612 +-158.94106,55.1543092,13.719616,-314630.1433626,583003.765703124,144.852142333984,120,2.16092492271512,0.153679988484144 +-158.8831,55.1567674,13.719616,-310926.030001133,583003.759627096,166.207107543945,120,2.22064959165696,0.370617033198627 +-158.82514,55.1591966,13.719616,-307222.390631535,583003.784104519,190.997009277344,120,2.28102656690995,0.589923440621929 +-158.76716,55.1615969,13.719616,-303517.947697043,583003.757772963,200.134033203125,120,2.30132094758437,0.663638423824359 +-158.70918,55.1639682,13.719616,-299813.967620199,583003.762114073,199.554336547852,120,2.30006116994685,0.659062551868544 +-158.6512,55.1663105,13.719616,-296110.444821594,583003.796089969,187.974334716797,120,2.2740985564351,0.564758929126222 +-158.5932,55.1686238,13.719616,-292406.102537911,583003.770615756,178.574508666992,120,2.25181946387284,0.483834905853952 +-158.5352,55.1709081,13.719616,-288702.206368567,583003.774968998,183.642684936523,120,2.26397363371603,0.527982319869881 +-158.47719,55.1731634,13.719616,-284998.115137991,583003.765235049,196.186584472656,120,2.29266930636351,0.632213193485959 +-158.41918,55.1753898,13.719616,-281294.458110764,583003.795566402,182.178665161133,120,2.26049751563744,0.515356066825575 +-158.36115,55.1775871,13.719616,-277589.960007491,583003.759169638,170.341262817383,120,2.23131986254428,0.409374502659884 +-158.30313,55.1797554,13.719616,-273886.521262033,583003.793261482,147.924591064453,120,2.17004037734944,0.186789921525796 +-158.24509,55.1818947,13.719616,-270182.229510152,583003.773168499,137.866317749023,120,2.13945817623761,0.0757066380583598 +-158.18705,55.184005,13.719616,-266478.350341583,583003.781550636,123.40251159668,120,2.09132399893125,-0.0991304327803573 +-158.129,55.1860863,13.719616,-262774.242571201,583003.777914885,106.859878540039,120,2.02881467621577,-0.326182134819969 +-158.07094,55.1881385,13.719616,-259069.901285629,583003.751907417,92.2873916625977,21,1.96514237160672,-0.557458119045132 +-158.01288,55.1901618,13.719616,-255365.955104889,583003.764982195,85.0113677978516,21,1.92947700385283,-0.68700491463674 +-157.95482,55.1921559,13.719616,-251662.400447809,583003.782906428,78.2852783203125,21,1.89368009992035,-0.817029487173103 +-157.89674,55.1941211,13.719616,-247957.958514837,583003.763476974,77.3523712158203,21,1.88847363141821,-0.835940866846927 +-157.83866,55.1960572,13.719616,-244253.896202521,583003.760504251,79.4783096313477,21,1.90024862183002,-0.793170740754389 +-157.78058,55.1979642,13.719616,-240550.207878858,583003.773136878,79.0351409912109,21,1.89782023236941,-0.801991344406673 +-157.72249,55.1998422,13.719616,-236846.251695486,583003.775990628,77.9003067016602,21,1.89153916753876,-0.824805964665997 +-157.66439,55.2016912,13.719616,-233142.022046792,583003.769914386,79.5711212158203,21,1.90075547763395,-0.791329695803465 +-157.60629,55.203511,13.719616,-229438.150125714,583003.768079299,80.9678192138672,21,1.90831244215208,-0.763880643701187 +-157.54818,55.2053019,13.719616,-225733.992890463,583003.769051993,84.1708068847656,21,1.92516149046355,-0.702680091036749 +-157.49007,55.2070636,13.719616,-222030.182106541,583003.77379252,86.3523330688477,21,1.93627407583791,-0.662316009109413 +-157.43195,55.2087963,13.719616,-218326.075363128,583003.770890723,93.202507019043,21,1.96942759443438,-0.541892966610732 +-157.37383,55.2104999,13.719616,-214622.303204626,583003.782454527,92.7759094238281,21,1.96743522015706,-0.549129838666187 +-157.3157,55.2121744,13.719616,-210918.224397292,583003.775974428,98.0380249023438,21,1.99139455326697,-0.462102702136485 +-157.25757,55.2138198,13.719616,-207214.468888365,583003.783588158,99.9724731445312,21,1.99988043592879,-0.431279554196697 +-157.19943,55.2154362,13.719616,-203510.394905377,583003.785050043,106.49259185791,21,2.02731939719134,-0.33161341503185 +-157.14128,55.2170235,13.719616,-199805.997357801,583003.770199479,109.456321716309,21,2.03924084956977,-0.288311297272105 +-157.08313,55.2185816,13.719616,-196101.906706095,583003.758415194,107.537635803223,21,2.03156048435515,-0.316208575926081 +-157.02498,55.2201107,13.719616,-192398.116258324,583003.771258083,104.955085754395,21,2.02100348781176,-0.3545546006385 +-156.96682,55.2216107,13.719616,-188693.985300188,583003.76851801,103.817176818848,21,2.01626921459613,-0.371750832253774 +-156.90866,55.2230815,13.719616,-184990.144259531,583003.767937237,106.824745178223,122,2.02867186551616,-0.326700864043202 +-156.85049,55.2245233,13.719616,-181285.950908428,583003.763820191,107.579635620117,122,2.031730068962,-0.315592596229752 +-156.79232,55.225936,13.719616,-177582.035682307,583003.772819605,116.214744567871,122,2.06526123199778,-0.193797841337004 +-156.73415,55.2273195,13.719616,-173878.393385479,583003.783186191,148.785125732422,122,2.17255951632263,0.195940153310276 +-156.67597,55.2286739,13.719616,-170174.382293935,583003.779811437,248.977676391602,122,2.39616040952721,1.00812241947823 +-156.61778,55.2299992,13.719616,-166469.996751604,583003.763771418,288.031982421875,122,2.45944071351675,1.23797454556521 +-156.5596,55.2312954,13.719616,-162766.502283652,583003.785172821,243.707153320312,122,2.38686827683325,0.97437074129504 +-156.5014,55.2325625,13.719616,-159061.986458746,583003.769917314,185.252227783203,122,2.26776343936734,0.541747975713679 +-156.44321,55.2338004,13.719616,-155358.350800855,583003.7798442,187.901626586914,122,2.27393053962508,0.564148644115445 +-156.38501,55.2350092,13.719616,-151654.318038795,583003.778190759,199.494232177734,122,2.2999303437842,0.658587353904315 +-156.32681,55.2361889,13.719616,-147950.518102902,583003.788374957,218.711456298828,221,2.33987153236116,0.803665151166036 +-156.2686,55.2373394,13.719616,-144246.310120765,583003.777026402,262.466918945312,320,2.41907457317107,1.09135320218616 +-156.21039,55.2384608,13.719616,-140542.323621146,583003.77760225,380.404632568359,320,2.58024579713663,1.67677309047638 +-156.15217,55.2395531,13.719616,-136837.917349602,583003.76900296,570.063049316406,420,2.75592289156006,2.31488244065722 +-163.19532,54.8595216,8.318035048,-588726.263772342,579299.788999867,13.1723051071167,12,1.11966178162099,-3.62848494605952 +-163.1382,54.8641005,13.64967272,-585022.45948626,579299.805955276,44.2939796447754,12,1.64634470173703,-1.71542224992603 +-163.08106,54.8686511,13.719616,-581318.247390827,579299.77648879,96.0064010620117,12,1.98230018984409,-0.495136025878133 +-163.02391,54.8731733,13.719616,-577614.259951501,579299.77797497,92.1566162109375,12,1.96452652002991,-0.559695067753672 +-162.96675,54.8776671,13.719616,-573910.491945652,579299.810174348,86.188232421875,12,1.93544797414127,-0.665316646264518 +-162.90957,54.8821325,13.51257846,-570206.30199874,579299.786998643,68.0534362792969,12,1.83285005928893,-1.03798155736861 +-162.85238,54.8865695,13.33474274,-566502.321030853,579299.795206707,34.3406600952148,12,1.5358086389016,-2.11692078027772 +-162.79517,54.890978,13.719616,-562797.909131124,579299.738815416,42.4378089904785,12,1.62775295374231,-1.78295278525607 +-162.73796,54.895358,13.719616,-559094.333333949,579299.787673772,38.7432975769043,12,1.5881965822712,-1.92663281695163 +-162.68073,54.8997097,13.719616,-555390.313173773,579299.794735093,27.645055770874,12,1.44161747041722,-2.4590499890491 +-162.62349,54.9040328,13.719616,-551686.483910948,579299.811465697,21.8999996185303,12,1.34044410727527,-2.82654052173353 +-162.56623,54.9083275,13.719616,-547982.201232305,579299.777260935,21.8999996185303,12,1.34044410727527,-2.82654052173353 +-162.50896,54.9125937,13.719616,-544278.097462214,579299.764562086,19.5514373779297,12,1.29117869126417,-3.00548657443553 +-162.45168,54.9168314,12.69465841,-540574.167322484,579299.773228432,21.7971057891846,12,1.33839883198851,-2.83396954535473 +-162.16509,54.9375922,13.719616,-522054.394273513,579299.796387503,75.0336761474609,12,1.87525622449157,-0.883950261428033 +-161.53352,54.9807528,13.719616,-481310.297005225,579299.786837046,56.5949058532715,13,1.75277734179995,-1.32882852231759 +-161.47603,54.9845048,13.719616,-477605.97811044,579299.745767373,80.192497253418,13,1.90413373793676,-0.779058890132157 +-161.41854,54.9882282,13.719616,-473902.374516138,579299.790243077,89.4660186767578,13,1.95165811125426,-0.606436801436379 +-161.36103,54.991923,13.719616,-470198.208565206,579299.777065757,53.7807159423828,13,1.73062657936286,-1.40928641394613 +-161.30351,54.9955891,13.719616,-466494.112266288,579299.767176064,92.8056335449219,13,1.96757433983108,-0.548624516301443 +-161.24598,54.9992265,13.719616,-462790.080226072,579299.760671468,72.1831436157227,13,1.85843579189961,-0.945046873631483 +-161.18844,55.0028353,13.719616,-459086.105846051,579299.768728582,103.340370178223,13,2.01427001290997,-0.37901250340688 +-161.13089,55.0064153,13.719616,-455382.186142664,579299.769335256,93.8280334472656,13,1.97233261399226,-0.531341106401362 +-161.07333,55.0099667,13.719616,-451678.313319288,579299.784760219,139.655838012695,13,2.14505909516559,0.0960507742662237 +-161.01576,55.0134894,13.719616,-447974.483175118,579299.804081275,96.2434539794922,13,1.98337120054664,-0.491245809309588 +-160.95817,55.0169834,13.719616,-444270.05415538,579299.760558363,117.812461853027,13,2.07119123126395,-0.172258391411992 +-160.90058,55.0204487,13.719616,-440566.29314937,579299.788712211,91.1167678833008,13,1.95959830594217,-0.577595747972683 +-160.84297,55.0238852,13.719616,-436861.923593645,579299.744413648,86.6401901245117,13,1.93771939664053,-0.657066191418682 +-160.78536,55.027293,13.719616,-433158.211208335,579299.771047934,90.4393157958984,13,1.95635726810068,-0.589368122497274 +-160.72774,55.0306721,13.719616,-429454.514428908,579299.802480646,97.2343063354492,13,1.98781952031227,-0.475088242243924 +-160.6701,55.0340225,13.719616,-425750.191688443,579299.774820203,82.3359298706055,13,1.91558939462132,-0.737448675283896 +-160.61246,55.0373441,13.719616,-422046.51097085,579299.805992035,99.9812164306641,13,1.99991841633247,-0.431141598529848 +-160.5548,55.040637,13.719616,-418342.193429761,579299.779653788,78.8564147949219,13,1.89683702799745,-0.805562623320084 +-160.49714,55.043901,13.719616,-414638.5081126,579299.800442121,99.2260513305664,13,1.99662570908734,-0.443101651076377 +-160.43946,55.0471364,13.719616,-410934.174003079,579299.776430431,156.296234130859,13,2.19394851406595,0.273631098141776 +-160.38178,55.0503429,13.719616,-407230.461202593,579299.798965726,144.998916625977,13,2.16136475737209,0.155277593499589 +-160.32408,55.0535207,13.719616,-403526.089806557,579299.76729967,89.9905319213867,13,1.9541968188771,-0.597215490730933 +-160.26638,55.0566697,13.719616,-399822.327727331,579299.792731168,69.1547241210938,13,1.83982185313144,-1.01265801218455 +-160.20866,55.0597898,13.719616,-396117.898241159,579299.743519715,47.6467933654785,13,1.67803367789063,-1.60031884360187 +-159.91996,55.0749586,11.78649368,-377598.252387219,579299.784756328,43.4289970397949,13,1.6377797997718,-1.74653241853016 +-159.86219,55.0779058,13.71856958,-373894.151263597,579299.76837582,106.659271240234,13,2.02799861199803,-0.329146312986736 +-159.74663,55.0837138,9.819250996,-366486.367717613,579299.786997752,26.13991355896,13,1.41730414709576,-2.54736291906603 +-159.68883,55.0865745,13.59440045,-362782.039131586,579299.755992529,75.4145965576172,13,1.8774554120622,-0.875962184460866 +-159.63103,55.0894064,9.273982239,-359078.259565976,579299.778911197,71.2754135131836,13,1.8529397456023,-0.965010082511091 +-159.5154,55.0949835,9.847465944,-351670.41986304,579299.789469681,43.9250793457031,13,1.64271255467205,-1.72861524478402 +-159.45757,55.0977288,13.57432302,-347966.347770216,579299.789126255,69.5568313598633,13,1.84233978962926,-1.00351214813384 +-159.39973,55.1004452,13.719616,-344262.167447421,579299.778272566,84.8562393188477,13,1.92868378067991,-0.689886127609212 +-159.34189,55.1031326,13.719616,-340558.510412412,579299.797581869,59,13,1.77085201164214,-1.26317616242633 +-159.28403,55.1057912,13.719616,-336854.097040944,579299.766634251,57,13,1.75587485567249,-1.31757746781402 +-159.22617,55.1084209,13.719616,-333150.195005425,579299.77685107,72.3332061767578,13,1.85933771567107,-0.941770829058876 +-159.1683,55.1110217,13.719616,-329446.162625547,579299.777479926,81.8042144775391,13,1.9127756786981,-0.747668894631512 +-159.11042,55.1135935,13.719616,-325741.995223916,579299.757959867,79.5707855224609,13,1.90075364543555,-0.791336350871022 +-159.05254,55.1161365,13.719616,-322038.321692608,579299.789536954,81.4114990234375,13,1.91068575144598,-0.755260106935834 +-158.99465,55.1186505,13.719616,-318334.502047961,579299.800965813,80.7587661743164,13,1.90718967520747,-0.767958853713606 +-158.93674,55.1211356,13.719616,-314629.893746327,579299.756548956,84.254997253418,120,1.9255956687745,-0.701103031484557 +-158.87884,55.1235917,13.719616,-310926.400510832,579299.787900408,134.953369140625,120,2.1301837312854,0.0420192068018223 +-158.82092,55.1260189,13.719616,-307222.107515901,579299.764596724,176.229263305664,120,2.24607802573858,0.462980363780755 +-158.763,55.1284172,13.719616,-303518.281515041,579299.780331718,197.817535400391,120,2.29626478670545,0.645273004340148 +-158.70507,55.1307865,13.719616,-299814.281601672,579299.777807445,199.538604736328,120,2.30002693111057,0.65893818664244 +-158.64713,55.1331269,13.719616,-296110.101420592,579299.768768527,188.639785766602,120,2.27563329453412,0.570333535959706 +-158.58919,55.1354383,13.719616,-292406.372340126,579299.786788671,179.516662597656,120,2.25410476566288,0.492135774245478 +-158.53124,55.1377207,13.719616,-288702.452631345,579299.787384913,178.292892456055,120,2.25113403061988,0.4813452166371 +-158.47328,55.1399742,13.719616,-284998.335963072,579299.782341419,180.845458984375,120,2.25730760813337,0.503769412280538 +-158.41531,55.1421987,13.719616,-281294.017520742,579299.761237459,179.80322265625,120,2.25479747143105,0.494651879313357 +-158.35734,55.1443942,13.719616,-277590.127868195,579299.766571574,169.931884765625,120,2.23027487432859,0.405578807191167 +-158.29936,55.1465608,13.719616,-273886.024549635,579299.767253231,153.745834350586,120,2.18680335766331,0.247677850656692 +-158.24138,55.1486983,13.719616,-270182.33957611,579299.782468323,143.389129638672,120,2.1565162286199,0.137666353163727 +-158.18339,55.1508069,13.719616,-266478.429778043,579299.793378924,127.654747009277,120,2.10603696925075,-0.0456887250801037 +-158.12539,55.1528864,13.719616,-262774.290975741,579299.778510061,105.215705871582,120,2.02208057312801,-0.350642319339112 +-158.06738,55.154937,13.719616,-259069.916184217,579299.760850304,89.359489440918,21,1.95114067875543,-0.608316263962047 +-158.00937,55.1569585,13.719616,-255365.937330794,579299.757399576,80.1746978759766,21,1.90403733204241,-0.779409063857438 +-157.95136,55.1589511,13.719616,-251662.347466335,579299.789500855,76.4166412353516,21,1.88318794509003,-0.855139988275975 +-157.89334,55.1609146,13.719616,-247958.506178712,579299.796714266,76.6791076660156,21,1.88467705024175,-0.84973113333199 +-157.83531,55.1628491,13.719616,-244254.407197428,579299.790967124,76.6729049682617,21,1.88464191803367,-0.849858743539478 +-157.77727,55.1647545,13.719616,-240550.045555392,579299.76196769,76.1270904541016,21,1.8815392315551,-0.861128586424549 +-157.71923,55.166631,13.719616,-236846.05052428,579299.768451004,78.0356750488281,21,1.89229319159796,-0.82206713406309 +-157.66119,55.1684784,13.719616,-233142.417757502,579299.78735967,78.0408325195312,21,1.89232189368904,-0.821962879875898 +-157.60314,55.1702968,13.719616,-229438.50486902,579299.794452414,79.2335357666016,21,1.89890903658621,-0.798036496715598 +-157.54508,55.1720861,13.719616,-225734.306847426,579299.779485612,83.0939178466797,21,1.91956923627154,-0.722992754450384 +-157.48702,55.1738464,13.719616,-222030.453621154,579299.787898547,86.2382125854492,21,1.93569974654024,-0.664402137048456 +-157.42895,55.1755777,13.719616,-218326.303433223,579299.786043963,92.4161376953125,21,1.96574781429453,-0.555258978392485 +-157.37088,55.1772798,13.719616,-214622.487952987,579299.784910887,98.784049987793,21,1.99468682756853,-0.450144222164552 +-157.3128,55.178953,13.719616,-210918.363696903,579299.785353973,101.434013366699,21,2.00618360924299,-0.408384629614734 +-157.25471,55.1805971,13.719616,-207213.926173272,579299.766069819,105.006217956543,21,2.02121501663433,-0.353786267578589 +-157.19663,55.1822121,13.719616,-203510.442037521,579299.789296493,111.475273132324,21,2.04717854511419,-0.259479321410914 +-157.13853,55.183798,13.719616,-199805.99719965,579299.762391421,117.278663635254,21,2.06921900863452,-0.179422066930445 +-157.08044,55.1853549,13.719616,-196102.493945241,579299.787712343,119.961067199707,21,2.07904032068271,-0.143748258289888 +-157.02233,55.1868827,13.719616,-192398.018717759,579299.764866051,126.196044921875,122,2.10104574400858,-0.0638182797971765 +-156.96423,55.1883815,13.719616,-188694.473819973,579299.792890216,129.921783447266,122,2.11368197353496,-0.0179198874183936 +-156.90611,55.1898511,13.719616,-184989.946160791,579299.763637694,136.352188110352,122,2.13466211166985,0.0582859626151543 +-156.848,55.1912917,13.719616,-181286.337553658,579299.783949935,144.142959594727,122,2.15879343490438,0.145937816368349 +-156.78988,55.1927032,13.719616,-177582.370547582,579299.786915461,167.269622802734,122,2.22341707756126,0.38066933192217 +-156.73175,55.1940856,13.719616,-173878.03949136,579299.773586008,302.778930664062,122,2.48112565083234,1.31674042739277 +-156.67362,55.1954389,13.719616,-170173.974881605,579299.770650444,388.926849365234,122,2.58986792547882,1.71172340704407 +-156.61549,55.1967631,13.719616,-166470.171065087,579299.777512784,404.744201660156,221,2.60718063579469,1.7746081124508 +-156.55735,55.1980582,13.719616,-162765.98623875,579299.769080919,372.280395507812,320,2.57087016663216,1.64271812441279 +-156.49921,55.1993242,13.719616,-159062.050896269,579299.770408741,309.349212646484,320,2.49044901499406,1.35060554718121 +-156.44107,55.2005611,13.719616,-155358.359381534,579299.78093855,270.4345703125,221,2.43206220774407,1.13852799799529 +-156.38292,55.2017689,13.719616,-151654.269888677,579299.777289727,293.242584228516,320,2.46722703811286,1.2662566989366 +-156.32477,55.2029476,13.719616,-147950.41290862,579299.782881253,345.920013427734,320,2.53897568913142,1.52686827853988 +-156.26661,55.2040972,13.719616,-144246.146633724,579299.775473529,372.312591552734,420,2.57090772423719,1.64285454435426 +-156.20845,55.2052177,13.719616,-140542.101553189,579299.777395625,448.802825927734,420,2.65205558283134,1.93760672867302 +-163.24443,54.8219559,12.29198205,-592430.339915396,575595.795609127,31.8119831085205,12,1.50259074317974,-2.23757765887091 +-163.18737,54.8265595,13.719616,-588726.420351272,575595.802001267,91.1644592285156,12,1.95982556015657,-0.576770295801156 +-163.13029,54.8311348,13.719616,-585022.095942669,575595.758740544,98.3227615356445,12,1.99265406783252,-0.457527785733138 +-163.0732,54.8356817,13.719616,-581317.9997261,575595.743753346,87.7298126220703,12,1.94314720177065,-0.637350853936267 +-163.0161,54.8402003,13.719616,-577614.124977834,575595.767819745,71.2224884033203,12,1.85261714317917,-0.9661818665918 +-162.95899,54.8446904,13.719616,-573910.46949958,575595.80865072,59.5581321716309,12,1.77494106919643,-1.24832353825594 +-162.90186,54.8491522,13.719616,-570206.388357996,575595.802217465,43.7671966552734,12,1.64114873038887,-1.73429550094044 +-162.84472,54.8535855,13.719616,-566502.516017357,575595.813223771,47.5,12,1.67669360962487,-1.60518635403669 +-162.78756,54.8579905,13.719616,-562798.207576151,575595.778784422,46.8590126037598,12,1.67079313306042,-1.62661856908244 +-162.73039,54.862367,13.719616,-559094.097454677,575595.762505088,41.5168418884277,12,1.61822431009586,-1.81756353872564 +-162.67321,54.8667151,13.719616,-555390.178939394,575595.775237999,36.5999984741211,12,1.56348106728838,-2.01640662187954 +-162.61602,54.8710347,13.719616,-551686.448231653,575595.805778801,29.2999992370605,12,1.46686760904556,-2.36733427844386 +-162.55881,54.8753259,13.719616,-547982.26192435,575595.782491532,25.6000003814697,12,1.40823997178334,-2.58028659097394 +-162.50159,54.8795886,13.719616,-544278.252900515,575595.777821284,29.2999992370605,12,1.46686760904556,-2.36733427844386 +-162.44436,54.8838229,13.10571396,-540574.41447274,575595.802671336,16.2269134521484,12,1.21023591981523,-3.29949382370518 +-162.2153,54.9004751,11.66360952,-525758.128579785,575595.767882538,20.1000003814697,12,1.30319606566279,-2.9618360405196 +-162.15801,54.9045669,13.67842335,-522054.434337257,575595.80710913,57.2717056274414,12,1.75794011717227,-1.3100758485625 +-161.52698,54.9476923,13.719616,-481310.473734763,575595.806387404,55.5518074035645,13,1.74469819347716,-1.35817429504446 +-161.46954,54.9514413,13.719616,-477606.212622608,575595.778392234,70.7430877685547,13,1.84968401181996,-0.976835836887493 +-161.41209,54.9551616,13.719616,-473902.030414887,575595.750706414,107.906402587891,13,2.03304721415553,-0.31080834893616 +-161.35463,54.9588534,13.719616,-470197.919265375,575595.745533708,66.4704437255859,13,1.82262857793061,-1.07510889516329 +-161.29717,54.9625165,13.719616,-466494.512991094,575595.811083787,126.450355529785,13,2.10192005475126,-0.0606425336266443 +-161.23968,54.9661509,13.719616,-462789.896081406,575595.736726734,112.221099853516,13,2.05007452080989,-0.248960311090353 +-161.18219,54.9697568,13.719616,-459085.970859537,575595.755438886,104.123481750488,13,2.0175486819088,-0.367103441777832 +-161.12469,54.9733339,13.719616,-455382.098856251,575595.763903864,116.020133972168,110,2.06453336262563,-0.196441670651267 +-161.06718,54.9768824,13.719616,-451678.27227955,575595.784392446,107.754081726074,13,2.03243373022521,-0.313036697676829 +-161.00966,54.9804022,13.719616,-447974.486929968,575595.805985785,81.6482543945312,13,1.91194690413788,-0.750679240390018 +-160.95212,54.9838933,13.719616,-444270.100697447,575595.761946673,95.8645324707031,13,1.9816579585644,-0.497468793197014 +-160.89458,54.9873558,13.719616,-440566.380435573,575595.797870946,104.47297668457,13,2.01900396896871,-0.361817423795933 +-160.83702,54.9907895,13.719616,-436862.049639636,575595.758562634,82.1034393310547,13,1.91436135019146,-0.741909283171921 +-160.77946,54.9941946,13.719616,-433158.37401433,575595.798483673,93.4998016357422,13,1.97081068949718,-0.536869170567992 +-160.72188,54.9975709,13.719616,-429454.07701175,575595.764688785,85.5823516845703,13,1.93238421612314,-0.676445089869976 +-160.6643,55.0009185,13.719616,-425750.425485422,575595.798360692,111.42756652832,13,2.04699264604518,-0.260154559890413 +-160.6067,55.0042374,13.719616,-422046.140604205,575595.770956545,106.595611572266,13,2.02773932561757,-0.330088115128265 +-160.5491,55.0075275,13.719616,-418342.491456997,575595.799300482,110.176750183105,13,2.04208995810483,-0.277962521856216 +-160.49148,55.010789,13.719616,-414638.197006286,575595.779260341,135.785858154297,13,2.13285454133354,0.0517203512217304 +-160.43386,55.0140216,13.719616,-410934.528499603,575595.803293565,124.56103515625,13,2.09538220875065,-0.0843898563878841 +-160.37622,55.0172256,13.719616,-407230.20383721,575595.780605413,83.2697448730469,13,1.92048723404226,-0.719658324524492 +-160.31858,55.0204007,13.719616,-403526.494204416,575595.801440518,71.6648254394531,13,1.85530604735747,-0.956414999126575 +-160.26092,55.0235471,13.719616,-399822.118602613,575595.766181808,67.7129135131836,13,1.83067150077832,-1.04589470370166 +-160.20326,55.0266647,13.719616,-396118.346049331,575595.785026925,48.0497665405273,13,1.68169128190244,-1.58703338184686 +-160.14558,55.0297536,13.26237599,-392413.896637578,575595.749535493,24.4149322509766,13,1.38765552349756,-2.65505518253438 +-159.97251,55.0388474,12.96860148,-381302.17021492,575595.776357195,39.7595291137695,13,1.59944123225187,-1.88578903867917 +-159.9148,55.041821,13.719616,-377598.147380293,575595.767590186,50.7018241882324,13,1.70502358498681,-1.50228379734209 +-159.79935,55.0476819,13.21484383,-370189.895818546,575595.747966949,30.1522903442383,13,1.47932030639609,-2.32210252731305 +-159.74162,55.0505691,13.40863417,-366486.293820539,575595.782013409,47.8247032165527,13,1.67965228362744,-1.59443960556972 +-159.68387,55.0534275,13.719616,-362781.97219455,575595.757021968,63.4348220825195,13,1.80232772612599,-1.14884738335763 +-159.39502,55.0672867,9.425891961,-344262.118987114,575595.768681412,33.8666648864746,13,1.52977243039967,-2.13884601246219 +-159.33723,55.069972,11.82139663,-340558.460611962,575595.799940923,41,13,1.61278385671974,-1.83732481824772 +-159.27942,55.0726284,13.33419904,-336854.045003897,575595.767146249,47,13,1.67209785793572,-1.62187943592981 +-159.22161,55.0752559,13.719616,-333150.140049164,575595.77281819,68.3016586303711,13,1.8344312501716,-1.03223822076596 +-159.16379,55.0778545,13.719616,-329446.103512355,575595.766206561,74.270622253418,13,1.87081706253272,-0.900074564725547 +-159.10596,55.0804243,13.719616,-325741.929007616,575595.758954646,79.9185485839844,13,1.90264758798456,-0.78445701094797 +-159.04813,55.0829651,13.719616,-322038.249428966,575595.777908128,85.9518890380859,13,1.93425542598877,-0.669648321541545 +-158.99029,55.0854771,13.719616,-318334.420834782,575595.796229445,83.8741989135742,13,1.9236283852298,-0.708248766837537 +-158.93244,55.0879601,13.719616,-314630.439370202,575595.79229421,90.5141754150391,13,1.95671659934262,-0.58806292886321 +-158.87458,55.0904142,13.719616,-310926.29865173,575595.777795929,112.193740844727,120,2.0499686288237,-0.249344941008786 +-158.81671,55.0928395,13.719616,-307221.992332786,575595.764443534,149.117797851562,120,2.17352948146393,0.199463343559064 +-158.75884,55.0952358,13.719616,-303518.153201751,575595.776348184,190.225677490234,120,2.27926913951853,0.583539962716569 +-158.70096,55.0976031,13.719616,-299814.138979772,575595.767318326,196.737091064453,120,2.29388624566439,0.63663346437582 +-158.64307,55.0999416,13.719616,-296109.94253727,575595.760206914,201.508514404297,120,2.30429340124974,0.674435223959722 +-158.58518,55.1022511,13.719616,-292406.196599438,575595.777484701,196.185806274414,120,2.29266758367756,0.632206936198884 +-158.52728,55.1045316,13.719616,-288702.258882321,575595.774670712,190.260162353516,120,2.27934786300469,0.583825908888218 +-158.46937,55.1067833,13.719616,-284998.122309405,575595.774659444,182.705108642578,120,2.26175069088983,0.519907957034081 +-158.41146,55.1090059,13.719616,-281294.420281897,575595.78717197,176.943710327148,120,2.24783512973838,0.469362667035428 +-158.35354,55.1111996,13.719616,-277590.509023125,575595.791656406,174.932037353516,120,2.24286935419957,0.451325552905019 +-158.29561,55.1133644,13.719616,-273886.382978283,575595.788828889,161.891250610352,120,2.20922337800401,0.329113763845013 +-158.23767,55.1155002,13.719616,-270182.037300973,575595.768306466,149.295593261719,120,2.17404698890143,0.201343078283391 +-158.17973,55.117607,13.719616,-266478.103110778,575595.770953836,129.530166625977,120,2.11237092419715,-0.0226819928240439 +-158.12178,55.1196848,13.719616,-262773.938112567,575595.7562816,105.707908630371,120,2.02410748064747,-0.343280012691439 +-158.06383,55.1217337,13.719616,-259070.172741958,575595.775177551,85.5798110961914,21,1.93237132351304,-0.676491919509756 +-158.00587,55.1237536,13.719616,-255366.165401115,575595.777180585,78.7548294067383,21,1.89627719510149,-0.807596096190459 +-157.9479,55.1257445,13.719616,-251661.910497013,575595.763079937,76.9341354370117,21,1.88611907767632,-0.844493278094031 +-157.88993,55.1277064,13.719616,-247958.039141758,575595.77101426,75.3759307861328,21,1.8772326881039,-0.876771181449166 +-157.83195,55.1296393,13.719616,-244253.909032854,575595.763345586,75.0488815307617,21,1.87534422424567,-0.883630621203503 +-157.77397,55.1315432,13.719616,-240550.151279563,575595.777122194,75.0060348510742,21,1.87509620735278,-0.884531489349546 +-157.71598,55.1334181,13.719616,-236846.123576584,575595.775846724,76.5249633789062,21,1.88380313043739,-0.852905459502998 +-157.65799,55.1352639,13.719616,-233142.457643413,575595.784359476,77.6594314575195,21,1.89019420676416,-0.829691246089341 +-157.59999,55.1370808,13.719616,-229438.509936331,575595.789538494,77.9676666259766,21,1.89191453708554,-0.823442515330935 +-157.54198,55.1388687,13.719616,-225734.275475276,575595.7811439,80.1224746704102,21,1.90375435448957,-0.78043691909919 +-157.48397,55.1406275,13.719616,-222030.385946627,575595.782378923,87.8394546508789,21,1.94368963080764,-0.635380596849242 +-157.42595,55.1423573,13.719616,-218326.198435148,575595.770716066,92.6165313720703,21,1.9666885119831,-0.551842095885747 +-157.36793,55.1440581,13.719616,-214622.344040798,575595.779387651,99.6186294555664,21,1.99834056245178,-0.436872814188826 +-157.3099,55.1457299,13.719616,-210918.180449114,575595.775888642,104.403587341309,122,2.01871542142265,-0.362865510842908 +-157.25187,55.1473726,13.719616,-207214.33930259,575595.781239699,111.168022155762,122,2.04597987898579,-0.263833218922632 +-157.19383,55.1489863,13.719616,-203510.177719896,575595.775196923,122.858840942383,122,2.08940641384288,-0.106095649154572 +-157.13579,55.1505709,13.719616,-199806.327321695,575595.777689803,132.656158447266,122,2.12272741653155,0.0149357433717078 +-157.07774,55.1521265,13.719616,-196102.145243749,575595.769616227,140.37370300293,122,2.14728575658013,0.104138644076259 +-157.01969,55.1536531,13.719616,-192398.262578839,575595.780937931,149.127105712891,122,2.1735565890709,0.199561806124889 +-156.96163,55.1551506,13.719616,-188694.037501876,575595.771448331,164.480911254883,122,2.21611550339416,0.354147930470503 +-156.90357,55.156619,13.719616,-184990.101074254,575595.770017578,181.147567749023,122,2.25803250717945,0.506402452522682 +-156.84551,55.1580584,13.719616,-181286.447172752,575595.787124759,195.03596496582,122,2.29011470339323,0.622934146341601 +-156.78744,55.1594687,13.719616,-177582.433939858,575595.784273195,225.92985534668,122,2.35397362426073,0.854887974083038 +-156.72936,55.16085,13.719616,-173878.055269701,575595.773641416,424.029724121094,221,2.62739630133166,1.84803717980648 +-156.67128,55.1622022,13.719616,-170173.942696423,575595.770794752,528.522277832031,221,2.72306329804951,2.19552701796515 +-156.6132,55.1635253,13.719616,-166470.090569637,575595.77513835,539.602111816406,320,2.73207364068189,2.22825515421375 +-156.55512,55.1648193,13.719616,-162766.493237968,575595.78609014,519.057800292969,420,2.7152157219151,2.16702238152372 +-156.49703,55.1660843,13.719616,-159062.507923932,575595.790256789,465.718231201172,420,2.66812323933941,1.99596904327608 +-156.43893,55.1673202,13.719616,-155358.129412305,575595.777628445,448.045471191406,420,2.65132209186733,1.93494248013255 +-156.38083,55.168527,13.719616,-151653.988755492,575595.772170146,479.613891601562,320,2.68089175357304,2.04234793146942 +-156.32273,55.1697047,13.719616,-147950.080298422,575595.773350738,508.504058837891,420,2.7062944237757,2.13461768028943 +-156.26463,55.1708533,13.719616,-144246.398385151,575595.780651841,562.79248046875,420,2.75034828614589,2.29463388264214 +-156.20652,55.1719729,13.719616,-140542.300282398,575595.783534374,609.457946777344,420,2.78494374422408,2.42029446090895 +-163.35043,54.7797106,7.398716815,-599838.43858584,571891.811896248,54.149299621582,12,1.73359284374159,-1.39851209506643 +-163.29344,54.7843671,13.719616,-596134.168300854,571891.766372902,101.195755004883,12,2.00516229494823,-0.41209433464544 +-163.23644,54.7889954,13.719616,-592430.13701003,571891.767906887,78.2295455932617,12,1.89337080759599,-0.818152925176001 +-163.17943,54.7935953,13.68540882,-588726.342630893,571891.794183789,85.6952590942383,12,1.93295679618033,-0.674365315671641 +-163.1224,54.7981669,13.719616,-585022.141166208,571891.767870541,71.6781005859375,12,1.85538648833967,-0.95612281451905 +-163.06536,54.8027101,13.719616,-581318.166210977,571891.76689751,45.6667785644531,12,1.65960037659437,-1.66727385529789 +-163.00831,54.807225,13.719616,-577614.411044994,571891.802048014,57.2871208190918,12,1.75805699568647,-1.30965131243848 +-162.95124,54.8117115,13.719616,-573910.234709546,571891.775647735,62.1496925354004,12,1.7934389844578,-1.18113383019596 +-162.89416,54.8161697,13.719616,-570206.267761541,571891.786038673,58.7204666137695,12,1.76878949798056,-1.27066780074519 +-162.83707,54.8205994,13.719616,-566502.50795814,571891.810953286,42.0999984741211,12,1.62428208009503,-1.79555998902895 +-162.77996,54.8250008,13.719616,-562798.309844968,571891.787509138,46.5747184753418,12,1.66815023844804,-1.63621831667183 +-162.72284,54.8293738,13.719616,-559094.306941961,571891.790349783,42.1608009338379,12,1.62490885262769,-1.79328337229164 +-162.66571,54.8337183,13.719616,-555390.495463824,571891.808264657,41.1266593933105,12,1.6141234343822,-1.83245908982411 +-162.60856,54.8380345,13.719616,-551686.230004084,571891.780086645,37.1839599609375,12,1.57035563873348,-1.99143621619289 +-162.5514,54.8423222,13.68748359,-547982.145474477,571891.767778635,36.1423072814941,12,1.5580158739481,-2.03625776401291 +-162.49423,54.8465815,13.5630798,-544278.235184573,571891.782234174,29.6774787902832,12,1.47242700327895,-2.34714097177912 +-162.43705,54.8508123,13.61340639,-540574.495299318,571891.812283119,27.3999996185303,12,1.43775055677403,-2.4730957231282 +-162.20818,54.867451,13.69114544,-525757.941046715,571891.745527347,55.1460037231445,12,1.74151404580847,-1.36974002822336 +-161.52044,54.9146298,13.719616,-481309.930148709,571891.745057754,124.672576904297,13,2.09577093616596,-0.0829778874616152 +-161.46306,54.9183757,13.719616,-477606.370777479,571891.791542236,134.605239868164,13,2.12906196628867,0.0379446361500907 +-161.40566,54.9220931,13.719616,-473902.249062599,571891.785165241,114.032524108887,13,2.05702873753358,-0.223700611018851 +-161.34825,54.9257818,13.719616,-470198.199400657,571891.77636171,129.660079956055,13,2.11280628507857,-0.0211006378383665 +-161.29083,54.9294419,13.719616,-466494.215186185,571891.776287457,104.975608825684,13,2.02108840208938,-0.354246167745214 +-161.2334,54.9330734,13.719616,-462790.291059392,571891.785049314,106.685699462891,13,2.02810620892227,-0.328755490246678 +-161.17596,54.9366763,13.719616,-459086.421657948,571891.802765888,131.643218994141,110,2.11939849329949,0.00284414402357531 +-161.1185,54.9402505,13.719616,-455381.965543547,571891.749929884,120.082107543945,110,2.07947830154262,-0.142157386794489 +-161.06104,54.9437961,13.719616,-451678.190667464,571891.775447086,77.4853515625,13,1.88921960783698,-0.8332312675711 +-161.00357,54.947313,13.719616,-447974.455567263,571891.799273981,77.0127868652344,13,1.88656283950971,-0.842881408452918 +-160.94608,54.9508013,13.719616,-444270.116415431,571891.765747005,82.4548950195312,13,1.91621644308384,-0.735171056290558 +-160.88859,54.9542609,13.719616,-440566.443518425,571891.798324015,93.9516448974609,13,1.9729043880942,-0.529264259662536 +-160.83108,54.9576919,13.719616,-436862.155798685,571891.775028039,100.845237731934,13,2.00365539411471,-0.417567828585087 +-160.77357,54.9610941,13.719616,-433158.524672066,571891.80603385,88.1304779052734,13,1.94512612517784,-0.63016283928038 +-160.71604,54.9644677,13.719616,-429454.267922779,571891.782693112,74.1006774902344,13,1.86982217868007,-0.90368826684648 +-160.6585,54.9678126,13.719616,-425750.018545014,571891.759936953,72.5379791259766,13,1.8605654521727,-0.937311339654063 +-160.60096,54.9711288,13.719616,-422046.408387604,571891.801550235,102.170310974121,13,2.00932471523811,-0.396975236079559 +-160.5434,54.9744162,13.719616,-418342.158599115,571891.769042388,111.014427185059,13,2.04537942238763,-0.266014248674511 +-160.48583,54.977675,13.719616,-414637.898824029,571891.748934906,105.632499694824,13,2.02379755708629,-0.344405743526614 +-160.42826,54.980905,13.719616,-410934.263084695,571891.781218536,82.1110458374023,13,1.91440158371571,-0.741763143528049 +-160.37067,54.9841063,13.719616,-407229.970332673,571891.75294104,70.2186050415039,13,1.84645219754752,-0.988574708776634 +-160.31308,54.9872789,13.719616,-403526.289669596,571891.787593721,65.6511154174805,13,1.8172421091847,-1.09467408709967 +-160.25547,54.9904227,13.719616,-399821.942184581,571891.752318543,62.5252151489258,13,1.79605519481006,-1.17163100745577 +-160.19786,54.9935378,12.84960492,-396118.195908546,571891.779480846,39.352668762207,13,1.59497419004701,-1.902014610988 +-160.02496,55.0027104,12.96096427,-385006.054179015,571891.76097982,26.9894752502441,13,1.43119444075738,-2.49690940780251 +-159.96731,55.0057104,13.719616,-381302.112271618,571891.765560091,41.4830627441406,13,1.6178708133818,-1.8188475396891 +-159.90965,55.0086816,13.719616,-377598.108050311,571891.762494952,44.9893951416016,13,1.65311015434737,-1.69084819499286 +-159.85198,55.0116241,11.73809246,-373894.035062065,571891.763261965,29.3227195739746,13,1.46720424704677,-2.36611151313744 +-159.79431,55.0145377,13.12846105,-370190.527064815,571891.801825901,27.4938316345215,13,1.43923526882745,-2.46770282517118 +-159.73662,55.0174226,13.719616,-366486.302102631,571891.788736619,45.8308906555176,13,1.66115829719718,-1.66161504299369 +-159.67892,55.0202786,13.719616,-362781.993890801,571891.758537432,57.1897315979004,13,1.75731805832628,-1.31233534384442 +-159.62122,55.0231058,13.66144066,-359078.23324196,571891.776824485,33.7297668457031,13,1.52801333917395,-2.14523553388863 +-159.56351,55.0259042,13.71513232,-355374.377408161,571891.788862373,51.529727935791,13,1.71205784949976,-1.47673334085209 +-159.50579,55.0286738,13.22282422,-351670.420903773,571891.795112354,51.9743194580078,13,1.71578881147023,-1.46318142205275 +-159.33257,55.0368095,11.15554014,-340557.895160159,571891.750639729,17,13,1.23044892137827,-3.22607443266317 +-159.27482,55.0394637,13.25238651,-336854.120079882,571891.767119698,45,13,1.65321251377534,-1.69047639633417 +-159.21706,55.0420891,13.719616,-333150.216832968,571891.779182915,62.8284301757812,13,1.79815620861753,-1.16399952561801 +-159.15929,55.0446856,13.719616,-329446.180786227,571891.776264609,72.1476135253906,13,1.8582219702196,-0.945823535004058 +-159.10151,55.0472532,13.719616,-325742.006411616,571891.758909453,77.5862884521484,13,1.8897849767256,-0.831177686395293 +-159.04373,55.049792,13.719616,-322038.324598848,571891.787267142,85.3965682983398,13,1.93144041870962,-0.679873231462485 +-158.98594,55.0523019,13.719616,-318334.493415904,571891.801200344,81.459587097168,13,1.91094220440115,-0.754328596603711 +-158.92814,55.0547829,13.719616,-314630.507329258,571891.801290702,88.1005783081055,13,1.94497875920881,-0.630698114542322 +-158.87033,55.057235,13.719616,-310926.360803588,571891.788132183,98.6324768066406,120,1.9940199390341,-0.452566551670568 +-158.81251,55.0596582,13.719616,-307222.048301801,571891.762331186,116.410957336426,120,2.06599386078448,-0.19113672447064 +-158.75469,55.0620525,13.719616,-303518.201549383,571891.770209382,158.517868041992,120,2.20007822273467,0.295895949619588 +-158.69686,55.064418,13.719616,-299814.176954688,571891.776685023,173.314086914062,120,2.23883386346642,0.436667498718479 +-158.63902,55.0667545,13.719616,-296109.970558603,571891.760191148,194.881118774414,120,2.28976976415968,0.621681228589887 +-158.58118,55.0690621,13.719616,-292406.213285066,571891.776518249,205.677581787109,120,2.31318695753461,0.706739158860068 +-158.52333,55.0713408,13.719616,-288702.262324118,571891.781189403,202.437362670898,120,2.30629067073843,0.681689876820113 +-158.46547,55.0735906,13.719616,-284998.112128476,571891.774885291,199.25813293457,120,2.29941605662535,0.656719316151188 +-158.40761,55.0758114,13.719616,-281294.395151928,571891.789546485,194.173706054688,120,2.288190419761,0.615944598944138 +-158.34974,55.0780033,13.719616,-277590.4678219,571891.793514238,178.116134643555,120,2.25070326179497,0.47978054131136 +-158.29186,55.0801663,13.719616,-273886.324586283,571891.787506557,164.912948608398,120,2.21725475684765,0.358286024188892 +-158.23397,55.0823003,13.719616,-270181.960600735,571891.761142805,157.005172729492,120,2.19591396101349,0.280770162449628 +-158.17608,55.0844054,13.719616,-266478.00684566,571891.766401202,138.667999267578,120,2.14197624950161,0.0848529988828922 +-158.11819,55.0864815,13.719616,-262774.458454273,571891.791251551,111.654968261719,120,2.04787805244681,-0.256938511119558 +-158.06028,55.0885287,13.719616,-259070.034630334,571891.767879355,82.9922409057617,21,1.91903749129983,-0.724924203962776 +-158.00237,55.0905469,13.719616,-255366.005013341,571891.764529245,78.0652618408203,21,1.89245782072715,-0.821469154076023 +-157.94446,55.0925361,13.719616,-251662.364013014,571891.780318966,77.7480773925781,21,1.89068965830186,-0.827891624688489 +-157.88654,55.0944964,13.719616,-247958.468122097,571891.788156761,76.3257369995117,21,1.88267100652819,-0.857017656681518 +-157.82861,55.0964277,13.719616,-244254.312418028,571891.777744972,75.2813034057617,21,1.876687129774,-0.878752805021204 +-157.77068,55.0983301,13.719616,-240550.527938742,571891.797249619,74.1023178100586,21,1.8698317922759,-0.903653347522459 +-157.71274,55.1002034,13.719616,-236846.47309731,571891.787943413,74.0023574829102,21,1.86924555521085,-0.905782727871424 +-157.65479,55.1020478,13.719616,-233142.141042463,571891.772912623,72.9736251831055,21,1.86316592166601,-0.927865692206467 +-157.59684,55.1038632,13.719616,-229438.16407168,571891.776455651,74.0383834838867,21,1.86945692802128,-0.905014961492142 +-157.53888,55.1056496,13.719616,-225733.89932065,571891.763787601,77.1057891845703,21,1.88708698656622,-0.840977556737234 +-157.48092,55.107407,13.719616,-222029.978452395,571891.769232517,79.3291091918945,21,1.89943257750291,-0.796134846672692 +-157.42296,55.1091353,13.719616,-218326.396437957,571891.780901769,87.401123046875,21,1.94151701306835,-0.643272164605183 +-157.36499,55.1108347,13.719616,-214622.509252216,571891.787959641,92.9749755859375,122,1.96836607299074,-0.545748715482402 +-157.30701,55.1125051,13.719616,-210918.311873406,571891.780216412,108.003288269043,122,2.03343697822177,-0.30939261459785 +-157.24903,55.1141465,13.719616,-207214.435959539,571891.789815596,121.117385864258,122,2.08320648866706,-0.128615547027969 +-157.19104,55.1157588,13.719616,-203510.23917357,571891.77427286,139.332595825195,122,2.14405272827622,0.0923953624783116 +-157.13305,55.1173422,13.719616,-199806.35209183,571891.786883774,155.194458007812,122,2.19087620854846,0.262471607578942 +-157.07505,55.1188965,13.719616,-196102.132900014,571891.77518286,176.573455810547,122,2.24692541690032,0.466058330349695 +-157.01705,55.1204218,13.719616,-192398.212716651,571891.780254551,201.754913330078,221,2.30482411988064,0.676362945509345 +-156.95904,55.121918,13.719616,-188693.949161246,571891.761894101,223.477508544922,221,2.34923382095185,0.837671655590633 +-156.90103,55.1233853,13.719616,-184989.972883307,571891.771220475,244.172485351562,221,2.38769672376436,0.977379897011149 +-156.84302,55.1248234,13.719616,-181286.279727228,571891.774219337,275.097900390625,221,2.43948727576865,1.16549796438599 +-156.785,55.1262326,13.719616,-177582.22535465,571891.776891683,318.942291259766,320,2.50371210984499,1.39878089334394 +-156.72698,55.1276127,13.719616,-173878.442356818,571891.784226264,667.341064453125,320,2.82434784973715,2.56342141918386 +-156.55288,55.1315788,13.719616,-162766.114372337,571891.774672668,688.742980957031,420,2.83805718594745,2.6132176413338 +-156.49484,55.1328427,13.719616,-159062.085071927,571891.771303079,648.904479980469,420,2.81218077250069,2.51922712183145 +-156.4368,55.1340776,13.719616,-155358.298534145,571891.783050538,632.5712890625,420,2.801109476412,2.47901301437481 +-156.37875,55.1352834,13.719616,-151654.112271256,571891.775410185,670.973815917969,420,2.82670557259191,2.57198534155348 +-156.3207,55.1364601,13.719616,-147950.157895358,571891.7718031,681.272583007812,420,2.83332091163424,2.59601414116094 +-163.11452,54.7651968,12.27518352,-585021.960532075,568187.746228465,28.2939739227295,12,1.45169394892423,-2.42244934299833 +-163.05753,54.7697363,13.719616,-581318.11222166,568187.759360976,37.4504127502441,12,1.57345660852856,-1.98017260879226 +-163.00053,54.7742476,13.719616,-577614.480518848,568187.816710122,48.2537307739258,12,1.68353089678638,-1.58035137551002 +-162.94351,54.7787305,13.719616,-573910.425430496,568187.809581743,99.2645874023438,12,1.99679434176084,-0.442489129073657 +-162.88647,54.783185,13.719616,-570205.941737414,568187.739431644,59.2632331848145,12,1.7727853413057,-1.25615375726107 +-162.82943,54.7876112,13.719616,-566502.298386272,568187.789362256,47.6683578491211,12,1.67823019095894,-1.59960505204735 +-162.77237,54.792009,13.719616,-562798.216001858,568187.77698838,57.5220108032227,12,1.75983405931989,-1.30319651009745 +-162.7153,54.7963784,13.58187309,-559094.327177991,568187.787986654,53.2711334228516,12,1.72649193714626,-1.4243046146212 +-162.65821,54.8007195,13.719616,-555389.987414556,568187.749590334,44.9712867736816,12,1.65293531431275,-1.6914832639029 +-162.60112,54.8050321,13.719616,-551686.470024587,568187.807386952,42.0114936828613,12,1.62336812278275,-1.79887974285654 +-162.54401,54.8093164,13.719616,-547982.491242659,568187.816596915,46.0962829589844,12,1.66366590683248,-1.65250668905524 +-162.48688,54.8135722,13.719616,-544278.048693892,568187.756682392,44.5682792663574,12,1.64902586676394,-1.70568349326761 +-162.42975,54.8177996,13.71511053,-540574.411342064,568187.80302235,46.9356651306152,12,1.67150297668167,-1.62404021444053 +-162.3726,54.8219986,13.68108941,-536870.29829716,568187.792147447,38.2169799804688,12,1.58225636483206,-1.94820938219744 +-162.25826,54.8303112,13.10596124,-529461.902535115,568187.742405324,33.4120254516602,12,1.52390280355841,-2.16016617250792 +-161.51392,54.8815653,13.719616,-481309.941776586,568187.748736264,65.8517379760742,13,1.81856724146118,-1.08986082844109 +-161.45659,54.8853082,13.719616,-477606.451636972,568187.808277648,124.05933380127,13,2.09362944467346,-0.0907563958048949 +-161.39924,54.8890225,13.719616,-473902.398349371,568187.801073585,122.79753112793,13,2.08918963530437,-0.106883050681189 +-161.34188,54.8927082,13.719616,-470198.414383584,568187.79968475,133.099899291992,13,2.12417772687251,0.0202036844898517 +-161.28451,54.8963653,13.719616,-466494.494384765,568187.804209167,106.045822143555,13,2.02549356341608,-0.338245364448429 +-161.22712,54.8999939,13.719616,-462789.993964564,568187.756135736,120.149948120117,110,2.07972358761473,-0.141266437768987 +-161.16973,54.9035938,13.719616,-459086.185834519,568187.773386651,120.922409057617,110,2.08250679075527,-0.131157049557289 +-161.11233,54.9071651,13.719616,-455382.425591669,568187.79691556,113.657943725586,110,2.05559979461994,-0.22889093954209 +-161.05491,54.9107078,13.719616,-451678.07004901,568187.758855118,91.3768463134766,13,1.96083616518511,-0.573099489882114 +-160.99749,54.9142219,13.719616,-447974.389483234,568187.795945077,71.732780456543,13,1.85571766498476,-0.95491988641689 +-160.94005,54.9177073,13.719616,-444270.104041421,568187.761816735,84.5112762451172,13,1.9269146602432,-0.69631207799257 +-160.88261,54.9211641,13.719616,-440566.482815138,568187.802070696,91.8994064331055,13,1.96331270634085,-0.564103985529246 +-160.82515,54.9245923,13.719616,-436862.244785511,568187.783663171,89.3208923339844,13,1.95095305311178,-0.608997773853489 +-160.76768,54.9279918,13.719616,-433158.02352981,568187.762622209,75.6112823486328,13,1.87858660365159,-0.871853373733983 +-160.71021,54.9313626,13.719616,-429454.451461822,568187.803827048,66.5204544067383,13,1.82295520725922,-1.07392248421247 +-160.65272,54.9347047,13.719616,-425750.247526776,568187.77761291,88.9540481567383,13,1.9491657169183,-0.615489889064746 +-160.59522,54.9380182,13.719616,-422046.043030092,568187.760517174,87.7846450805664,13,1.94341855759216,-0.636365212139864 +-160.53772,54.941303,13.719616,-418342.471501275,568187.804707245,87.353889465332,13,1.94128224687734,-0.644124902419893 +-160.4802,54.9445591,13.719616,-414638.251878544,568187.783900607,78.985466003418,13,1.89754718476875,-0.802983131227831 +-160.42267,54.9477865,13.719616,-410934.016563994,568187.761920835,72.2940292358398,13,1.85910243039266,-0.942625452347156 +-160.36514,54.9509851,13.719616,-407230.399022701,568187.789292034,75.4841537475586,13,1.87785579053912,-0.874507895553316 +-160.30759,54.9541551,13.719616,-403526.116045915,568187.765274042,77.567138671875,13,1.88967777130837,-0.83156708707014 +-160.25004,54.9572964,13.719616,-399822.438925864,568187.801177884,57.9248275756836,13,1.76286474970344,-1.29218817757925 +-160.19247,54.9604089,10.0407585,-396118.087625924,568187.765275093,16.1735286712646,13,1.20880478275558,-3.304692121993 +-160.07732,54.9665477,13.71574036,-388710.527720036,568187.800900438,30.291805267334,13,1.48132515627372,-2.31482034031637 +-160.01972,54.969574,13.719616,-385006.03258186,568187.754951479,39.2170486450195,13,1.59347490688884,-1.90746043535651 +-159.96212,54.9725716,13.719616,-381302.116095287,568187.767857229,45.7595405578613,13,1.66048165533507,-1.66407279936967 +-159.90451,54.9755404,13.67918289,-377598.135986878,568187.770380011,45.7495193481445,13,1.66038653565831,-1.66441830118552 +-159.84689,54.9784804,13.719616,-373894.086785884,568187.762910476,44.1530609130859,13,1.64496081644323,-1.72044891631333 +-159.78926,54.9813917,13.719616,-370189.962050269,568187.756941168,48.660572052002,13,1.68717721017572,-1.56710692451849 +-159.73163,54.9842742,13.719616,-366486.395115596,568187.79698352,50.2624015808105,13,1.70124323571648,-1.51601510491103 +-159.67398,54.9871279,13.719616,-362782.104860768,568187.772537826,51.5973701477051,13,1.71262756675423,-1.47466396517036 +-159.61633,54.9899528,13.719616,-359078.361450889,568187.793854644,52.9445152282715,13,1.72382097616261,-1.43400630728201 +-159.55867,54.9927489,13.719616,-355374.521582864,568187.806200858,74.1151351928711,13,1.86990690513918,-0.90338051616367 +-159.50099,54.9955162,13.61638936,-351669.941951606,568187.757086484,47.8635787963867,13,1.68000516802198,-1.59315782872549 +-159.44331,54.9982547,12.63704819,-347965.892716225,568187.753452223,57.7944107055664,13,1.76188583985473,-1.29574385755844 +-159.32793,55.0036452,11.74570195,-340558.088731338,568187.764238059,32,13,1.50514997831991,-2.2282817863634 +-159.27023,55.0062973,13.719616,-336854.322100307,568187.789651161,47,13,1.67209785793572,-1.62187943592981 +-159.21252,55.0089205,13.719616,-333150.426956562,568187.796844733,61.9746017456055,13,1.79221374463322,-1.18558425095712 +-159.1548,55.0115148,13.719616,-329446.397776579,568187.786353298,71.7945098876953,13,1.85609123509688,-0.953562973142124 +-159.09707,55.0140804,13.719616,-325742.227327784,568187.780923317,85.3361282348633,13,1.93113293469884,-0.680990101154294 +-159.03933,55.0166171,13.719616,-322037.911828703,568187.758917457,90.5624313354492,13,1.95694807353275,-0.587222148535351 +-158.98159,55.0191249,13.719616,-318334.08357234,568187.768841018,85.9911117553711,13,1.93445356385886,-0.668928628243174 +-158.92384,55.0216039,13.719616,-314630.098381119,568187.773330492,83.7701873779297,13,1.9230894868774,-0.710206199470354 +-158.86608,55.024054,13.719616,-310925.951566337,568187.761881346,87.1177062988281,13,1.9401064324631,-0.648395795983232 +-158.80832,55.0264752,13.719616,-307222.275415637,568187.781362653,91.3959884643555,120,1.96092713417992,-0.57276906452784 +-158.75055,55.0288676,13.719616,-303518.425775111,568187.7961234,114.31526184082,120,2.0581042154415,-0.219794168285329 +-158.69277,55.031231,13.719616,-299814.398707888,568187.784588657,151.297485351562,120,2.1798317098671,0.222354835954467 +-158.63498,55.0335656,13.719616,-296110.187092674,568187.769613369,175.318023681641,120,2.24382656631117,0.454802420509897 +-158.57719,55.0358714,13.719616,-292406.423239227,568187.795887265,203.626327514648,120,2.30883392865067,0.690927715475465 +-158.51939,55.0381482,13.719616,-288702.465325604,568187.796723016,210.741760253906,120,2.32375060324356,0.745109335239636 +-158.46158,55.0403961,13.719616,-284998.307030858,568187.783909019,211.559951782227,120,2.32543345936455,0.751221949006053 +-158.40376,55.0426151,13.719616,-281293.942808768,568187.75814031,214.79280090332,120,2.33201972125304,0.775145132091355 +-158.34594,55.0448052,13.719616,-277590.004933582,568187.761923084,188.764343261719,120,2.27591996142837,0.571374791942505 +-158.28812,55.0469664,13.719616,-273886.487855889,568187.794303973,178.292953491211,120,2.25113417929225,0.481345756657585 +-158.23028,55.0490987,13.719616,-270182.110380606,568187.772975364,160.905502319336,120,2.20657089547297,0.3194791901984 +-158.17244,55.051202,13.719616,-266478.143298355,568187.769495097,139.307754516602,120,2.14397529194468,0.0921140916196453 +-158.11459,55.0532764,13.719616,-262773.942514678,568187.754489203,114.744773864746,120,2.05973291439763,-0.213878268799689 +-158.05674,55.0553219,13.719616,-259070.140296101,568187.767737349,82.2728576660156,21,1.91525658235576,-0.738657544426479 +-157.99888,55.0573385,13.719616,-255366.093263541,568187.769896006,79.7905960083008,21,1.90195170911556,-0.786984641623778 +-157.94102,55.0593261,13.719616,-251662.434340871,568187.788540578,78.5459976196289,21,1.89512406008261,-0.811784611716509 +-157.88315,55.0612848,13.719616,-247958.519466451,568187.796580424,78.4928665161133,21,1.89483018956742,-0.812852033306698 +-157.82527,55.0632145,13.719616,-244254.343719865,568187.783720073,72.7478637695312,21,1.86182024485071,-0.932753574494027 +-157.76738,55.0651153,13.719616,-240549.900878068,568187.761905249,72.6524429321289,21,1.86125022199407,-0.934824060210088 +-157.7095,55.0669871,13.719616,-236846.461642611,568187.792191606,72.4881973266602,21,1.86026729963058,-0.938394314788241 +-157.6516,55.0688299,13.719616,-233142.10695276,568187.766770169,71.627082824707,21,1.85507726389168,-0.957246005975613 +-157.5937,55.0706438,13.719616,-229438.106254565,568187.768395527,71.5096435546875,21,1.85436461327205,-0.959834556436837 +-157.5358,55.0724287,13.719616,-225734.454572361,568187.785158699,69.0992813110352,21,1.83947353038035,-1.01392321983771 +-157.47789,55.0741847,13.719616,-222030.507902778,568187.793964911,72.8342361450195,21,1.86233556988705,-0.930881766873622 +-157.41997,55.0759116,13.719616,-218326.261821286,568187.77348349,79.3634033203125,21,1.89962028328347,-0.795453045701117 +-157.36205,55.0776096,13.719616,-214622.347392993,568187.77918687,88.5511703491211,122,1.94719430547873,-0.622650618110093 +-157.30412,55.0792786,13.719616,-210918.121776324,568187.767454552,113.794486999512,122,2.05612122230785,-0.226996965349346 +-157.24619,55.0809187,13.719616,-207214.216645814,568187.781551832,138.49836730957,122,2.14144465374253,0.0829220913533926 +-157.18825,55.0825297,13.719616,-203509.989672378,568187.767876933,161.388519287109,122,2.20787263703043,0.324207487089119 +-157.13031,55.0841117,13.719616,-199806.072518469,568187.768604345,196.015090942383,221,2.29228950840091,0.630833658880645 +-157.07237,55.0856647,13.719616,-196102.459577028,568187.783041782,245.637344360352,221,2.39029439348183,0.986815374873741 +-157.01442,55.0871888,13.719616,-192398.506912598,568187.79266109,287.089965820312,221,2.45801801358664,1.23280689334007 +-156.95646,55.0886838,13.719616,-188694.209935954,568187.776224215,312.226257324219,221,2.49446942317069,1.36520881721747 +-156.8985,55.0901498,13.719616,-184990.200343847,568187.773727124,334.617889404297,320,2.52454915558001,1.47446699093852 +-156.84054,55.0915868,13.719616,-181286.47252479,568187.784527994,357.885711669922,320,2.55374435984075,1.58051230595445 +-156.78257,55.0929948,13.719616,-177582.383044182,568187.781257732,468.113128662109,420,2.67035082148539,2.0040602574455 +-163.39118,54.7091205,12.01277955,-603542.295848169,564483.783624773,32.841178894043,11,1.51641873852012,-2.18735043289183 +-163.3343,54.7137979,12.42275372,-599838.056492772,564483.758426923,41.5249481201172,11,1.61830909853076,-1.81725556292907 +-163.04972,54.7367603,13.719616,-581318.47766367,564483.8096483,42.1643104553223,12,1.62494500237693,-1.79315206608423 +-162.99276,54.7412679,13.719616,-577614.337934711,564483.790722613,80.5595397949219,12,1.90611697659848,-0.771855201240121 +-162.93579,54.7457472,13.719616,-573910.409473233,564483.802947446,93.4744491577148,12,1.9706929145487,-0.537296962797196 +-162.8788,54.7501982,13.719616,-570206.048710782,564483.760252825,74.5633926391602,12,1.87252566022234,-0.893868450234498 +-162.8218,54.7546208,13.719616,-566501.890309366,564483.738385634,55.7548751831055,12,1.74628284790947,-1.35241837784091 +-162.76479,54.759015,13.719616,-562797.929045939,564483.737154543,51.6197967529297,12,1.71281629022616,-1.47397846765326 +-162.70777,54.7633809,13.719616,-559094.158239478,564483.767412415,92.9428100585938,12,1.96821579892069,-0.546294553797334 +-162.65073,54.7677185,13.719616,-555389.934309542,564483.745365401,84.3464202880859,12,1.92606665560184,-0.699392272894628 +-162.59368,54.7720276,13.719616,-551685.893304411,564483.733533793,44.1382942199707,12,1.64481554529214,-1.7209765825986 +-162.53662,54.7763084,13.719616,-547982.027107626,564483.753841262,61.1492042541504,12,1.78639080985505,-1.20673481210248 +-162.47955,54.7805608,13.719616,-544278.331926825,564483.79511908,48.7176666259766,12,1.68768647921984,-1.56525711399037 +-161.56469,54.8447303,13.719616,-485014.005848131,564483.748040856,109.154075622559,13,2.03803995614541,-0.292673284958491 +-161.50742,54.8484987,13.719616,-481310.513106257,564483.80730171,144.293029785156,13,2.15924535258374,0.147579310369944 +-161.45013,54.8522386,13.719616,-477606.459256503,564483.807413803,88.1274566650391,13,1.94511123667973,-0.630216918555098 +-161.39283,54.8559499,13.719616,-473902.4785964,564483.810429208,102.400085449219,13,2.01030031904322,-0.39343156459435 +-161.33551,54.8596326,13.719616,-470197.927396276,564483.745635996,129.403854370117,110,2.1119472122426,-0.0242210355823988 +-161.27819,54.8632868,13.719616,-466494.075845948,564483.766358582,81.7523193359375,110,1.91250008256181,-0.748669938461464 +-161.22086,54.8669123,13.719616,-462790.282654841,564483.779225312,91.7045669555664,110,1.96239096439645,-0.567452015362664 +-161.16351,54.8705093,13.719616,-459085.901660497,564483.737360453,98.7734375,110,1.99464016829026,-0.450313701981137 +-161.10616,54.8740778,13.719616,-455382.204291125,564483.779717227,97.9874649047852,110,1.99117052190805,-0.462916447976978 +-161.04879,54.8776176,13.719616,-451677.910811538,564483.746613456,98.1208801269531,110,1.99176143509657,-0.460770082612881 +-160.99142,54.8811288,13.719616,-447974.291418086,564483.785857189,87.0757598876953,13,1.93989727312273,-0.649155522407499 +-160.93403,54.8846114,13.719616,-444270.063983706,564483.762152907,77.3193511962891,13,1.88828820111112,-0.836614402649362 +-160.87664,54.8880654,13.719616,-440566.499898098,564483.810035888,76.4550704956055,13,1.88340629308698,-0.854346886028327 +-160.81923,54.8914907,13.719616,-436862.31817025,564483.785393253,84.3097610473633,13,1.92587785841598,-0.700078038161768 +-160.76181,54.8948874,13.719616,-433158.150645213,564483.766399068,82.9297027587891,13,1.91871010876289,-0.726113350781193 +-160.70438,54.8982555,13.719616,-429453.991945883,564483.753272418,75.0018081665039,13,1.87507173362195,-0.884620384925415 +-160.64695,54.9015949,13.719616,-425750.476184793,564483.799277578,81.7109222412109,13,1.91228011224901,-0.749468933423349 +-160.5895,54.9049057,13.719616,-422046.3200892,564483.786955933,75.3473892211914,13,1.87706820865498,-0.877368617754752 +-160.53204,54.9081878,13.719616,-418342.157747814,564483.770151287,73.794563293457,13,1.86802436699072,-0.910218432048775 +-160.47457,54.9114412,13.719616,-414637.983745464,564483.749127299,69.8442993164062,13,1.84413096483157,-0.99700608854674 +-160.4171,54.914666,13.719616,-410934.429970604,564483.797115968,71.1641464233398,13,1.85226124458774,-0.967474591859453 +-160.35961,54.9178621,13.719616,-407230.215336936,564483.779015329,70.9039459228516,13,1.8506704050679,-0.97325297506632 +-160.30211,54.9210295,13.719616,-403525.972802259,564483.757560075,74.697151184082,13,1.87330403891546,-0.891041156649713 +-160.12957,54.9303594,12.98633645,-392414.301324284,564483.783335494,33.8071327209473,13,1.52900833857779,-2.14162141205276 +-160.07203,54.933412,12.41783536,-388709.892911539,564483.750580812,27.8605079650879,13,1.44498903040896,-2.44680352082006 +-160.01449,54.9364358,13.13998914,-385006.068841139,564483.763036876,43.8341827392578,13,1.64181291381863,-1.73188299714674 +-159.95694,54.9394309,13.719616,-381302.184272224,564483.773070517,46.6872444152832,13,1.66919824166366,-1.63241166986282 +-159.89938,54.9423973,13.63611998,-377598.233767532,564483.781065488,50.2820129394531,13,1.70141265546973,-1.51539972401003 +-159.84181,54.9453349,13.719616,-373894.212865608,564483.776329194,52.0584335327148,13,1.71649109580677,-1.46063052489056 +-159.78423,54.9482438,13.719616,-370190.115127887,564483.770356111,52.1272888183594,13,1.71706513751391,-1.45854544156241 +-159.72664,54.9511239,13.719616,-366485.936069543,564483.752476064,52.5066184997559,13,1.72021405001083,-1.44710769258446 +-159.66905,54.9539753,13.719616,-362782.307646912,564483.788836329,48.3284225463867,13,1.68420261987341,-1.57791148552908 +-159.61144,54.9567979,13.719616,-359077.94859227,564483.75897792,53.2154541015625,13,1.7260377724527,-1.42595427041972 +-159.55383,54.9595917,13.719616,-355374.130186782,564483.772050375,51.1841697692871,13,1.70913566322421,-1.48734755547987 +-159.49621,54.9623567,13.719616,-351670.208570214,564483.773892849,64.6188888549805,13,1.81035948589612,-1.11967373938007 +-159.3233,54.9704791,11.76124773,-340558.406217334,564483.790354924,23.3946876525879,13,1.36911725120962,-2.72239147883387 +-159.26564,54.973129,13.719616,-336854.016050486,564483.762721235,47.0398559570312,13,1.67246598319644,-1.62054229990947 +-159.20798,54.97575,13.719616,-333150.134512322,564483.76543877,58.7404899597168,13,1.76893756469127,-1.27012998018945 +-159.15031,54.9783423,13.719616,-329446.115977281,564483.769960986,73.6476745605469,13,1.86715903846356,-0.913361552248768 +-159.09263,54.9809057,13.719616,-325741.956686052,564483.75464298,80.0230255126953,13,1.90321496717081,-0.782396127797381 +-159.03495,54.9834403,13.719616,-322038.288650688,564483.779637744,87.1302490234375,13,1.94016895527533,-0.648168695283456 +-158.97726,54.9859461,13.719616,-318334.467993906,564483.79591403,84.1118927001953,13,1.9248574056542,-0.703784613858751 +-158.91956,54.988423,13.719616,-314630.490040317,564483.792958316,75.1005706787109,13,1.87564323715961,-0.882544520953311 +-158.86185,54.9908711,13.719616,-310926.348445696,564483.782471129,80.6908264160156,13,1.90682416342884,-0.769286496821044 +-158.80413,54.9932904,13.719616,-307222.037707232,564483.765065161,90.5815353393555,120,1.95703967761608,-0.586889416358268 +-158.74641,54.9956808,13.719616,-303518.191495133,564483.775964503,109.350158691406,120,2.03881941763202,-0.289842058358663 +-158.68868,54.9980423,13.719616,-299814.165894391,564483.768985794,130.876129150391,120,2.11686044163374,-0.00637478405847251 +-158.63094,55.000375,13.719616,-296109.954592447,564483.755881809,153.519790649414,120,2.18616436949275,0.245356863235828 +-158.5732,55.0026788,13.719616,-292406.191225467,564483.770238171,188.045486450195,120,2.27426291375789,0.565355921834849 +-158.51545,55.0049538,13.719616,-288702.231117053,564483.778688548,195.316940307617,120,2.29073991232555,0.625205083636193 +-158.45769,55.0071999,13.719616,-284998.069500972,564483.770812114,204.488037109375,120,2.31066790613625,0.697589245172391 +-158.39993,55.0094171,13.719616,-281294.339213505,564483.789662283,207.237564086914,120,2.31646847885814,0.71865858094657 +-158.34216,55.0116054,13.719616,-277590.39632974,564483.792476312,171.292907714844,120,2.23373938162241,0.418162886551173 +-158.28438,55.0137648,13.719616,-273886.235302981,564483.77997586,186.071807861328,120,2.26968057722671,0.548711567624524 +-158.2266,55.0158953,13.719616,-270182.488964773,564483.793578333,156.823913574219,120,2.1954122875669,0.278947941299756 +-158.16881,55.0179969,13.719616,-266478.513385519,564483.792231388,146.589767456055,120,2.16610365589536,0.172490625552383 +-158.11101,55.0200696,13.719616,-262774.303013898,564483.77669394,119.36353302002,120,2.07687166492409,-0.151625435001148 +-158.05321,55.0221135,13.719616,-259070.489997865,564483.797859416,82.369010925293,21,1.91576385107211,-0.736814999659794 +-157.9954,55.0241284,13.719616,-255366.431771054,564483.794162615,82.6779251098633,21,1.91738956901181,-0.730909928076719 +-157.93758,55.0261143,13.719616,-251662.1227487,564483.766397886,79.0617294311523,21,1.89796631005997,-0.801460748539844 +-157.87976,55.0280714,13.719616,-247958.194424361,564483.774936611,79.2500152587891,21,1.89899935450881,-0.797708436241416 +-157.82193,55.0299995,13.719616,-244254.00416932,564483.75992048,75.5753402709961,21,1.87838011122509,-0.872603413165852 +-157.7641,55.0318987,13.719616,-240550.184143684,564483.769517708,71.3937530517578,21,1.85366021270277,-0.962393140360415 +-157.70626,55.033769,13.719616,-236846.09040626,564483.767237459,72.1025314331055,21,1.8579505125437,-0.946809546764672 +-157.64842,55.0356104,13.719616,-233142.355774109,564483.78904419,68.4507293701172,21,1.83537808007745,-1.02879906429573 +-157.59057,55.0374228,13.719616,-229438.33690497,564483.788470774,66.895263671875,21,1.82539536987565,-1.06505911709783 +-157.53271,55.0392062,13.719616,-225734.0282044,564483.766399066,64.3572387695312,21,1.80859740253574,-1.12607412909362 +-157.47485,55.0409607,13.719616,-222030.061874205,564483.768273927,74.3827438354492,21,1.87147219460128,-0.89769493805922 +-157.41699,55.0426862,13.719616,-218326.432918979,564483.782212367,85.6272430419922,122,1.93261196117786,-0.675617854826303 +-157.35912,55.0443828,13.719616,-214622.496797762,564483.786262211,104.915977478027,122,2.02084163120744,-0.355142510023854 +-157.30124,55.0460505,13.719616,-210918.247940099,564483.781357022,124.388412475586,122,2.0947799251112,-0.0865775224752222 +-157.24336,55.0476891,13.719616,-207214.320241121,564483.777404914,146.148330688477,122,2.16479385919449,0.167733070081645 +-157.18547,55.0492988,13.719616,-203510.068622407,564483.765284984,194.011993408203,122,2.28782857791994,0.614630286097438 +-157.12758,55.0508796,13.719616,-199806.125889717,564483.776054668,276.941558837891,221,2.44238813241466,1.17603470371122 +-157.06969,55.0524313,13.719616,-196102.487496717,564483.786781831,355.37841796875,320,2.55069104968852,1.56942181198008 +-157.01179,55.0539541,13.719616,-192398.508419661,564483.790059424,401.263946533203,320,2.60343014023449,1.76098524207816 +-156.95388,55.0554479,13.719616,-188694.183576164,564483.775774015,432.959442138672,320,2.63644721533638,1.8809126828597 +-156.89597,55.0569127,13.719616,-184990.145738411,564483.772800981,455.104309082031,420,2.65811094757339,1.95960154178929 +-164.96839,54.5338792,12.6836872,-707254.053643372,560779.749337947,66.8795394897461,11,1.82529327403397,-1.06542995833588 +-163.38309,54.6761646,12.75272272,-603542.230971038,560779.780480819,48.5471878051758,11,1.6861640775794,-1.57078691128514 +-163.32626,54.6808381,13.719616,-599838.141125786,560779.761172869,71.9869155883789,11,1.85725356581791,-0.949341056201137 +-163.26942,54.6854835,12.62614198,-596134.28879521,560779.791352643,29.5467529296875,11,1.47050976060803,-2.35410494439542 +-163.04191,54.7037821,13.13954317,-581317.987861546,560779.743662058,36.8835296630859,12,1.56683247528427,-2.00423335145137 +-162.985,54.7082861,13.719616,-577613.981814109,560779.747106219,58.2441329956055,12,1.76525218487468,-1.28351633159544 +-162.92808,54.7127617,13.719616,-573910.186870624,560779.767739947,85.6527786254883,12,1.93274145629327,-0.675147491605545 +-162.87114,54.7172091,13.719616,-570205.955914724,560779.741549673,78.4222640991211,12,1.89443937649467,-0.814271577936061 +-162.81419,54.7216281,13.719616,-566501.925667869,560779.733260413,82.963005065918,12,1.91888447457565,-0.725480004380308 +-162.75723,54.7260189,13.719616,-562798.087982998,560779.764746599,91.3986511230469,12,1.96093978638875,-0.572723108094053 +-162.70026,54.7303812,13.719616,-559094.442053909,560779.802742357,69.1297454833984,12,1.83966495793322,-1.01322790032682 +-162.64327,54.7347153,13.719616,-555390.339355315,560779.796550629,119.9873046875,12,2.07913529774901,-0.143403274475926 +-162.58627,54.739021,13.719616,-551686.416521181,560779.808699906,45.8309593200684,12,1.66115894786341,-1.6616126795882 +-162.52925,54.7432983,13.719616,-547982.029381256,560779.756533942,54.0221366882324,12,1.73257175744413,-1.40222097194587 +-162.47223,54.7475472,13.70880765,-544278.450574983,560779.805506684,41.7654800415039,13,1.62081747743775,-1.80814441477625 +-161.55815,54.8116648,13.719616,-485014.417050376,560779.796762996,104.551918029785,13,2.01933200446226,-0.360625905252711 +-161.50092,54.8154302,13.719616,-481310.366983448,560779.798858982,133.618011474609,13,2.12586500422332,0.0263323574249154 +-161.44368,54.819167,13.719616,-477606.39394846,560779.800946169,129.090454101562,13,2.11089412852285,-0.0280461362325593 +-161.38643,54.8228752,13.719616,-473902.49260051,560779.803105119,140.961639404297,13,2.14910094200511,0.110731915645318 +-161.32916,54.826555,13.719616,-470198.016203049,560779.756750402,135.56364440918,13,2.13214323562655,0.0491366858670895 +-161.27189,54.8302062,13.719616,-466494.239770755,560779.782027116,79.3794250488281,13,1.8997079489548,-0.79513461896059 +-161.21461,54.8338288,13.719616,-462790.519013493,560779.807692079,75.2416534423828,13,1.87645833064513,-0.879583868763057 +-161.15731,54.8374229,13.719616,-459086.208441464,560779.775809749,93.4617385864258,13,1.97063385556127,-0.537511481896659 +-161.1,54.8409884,13.719616,-455381.942850809,560779.745699982,111.967147827148,110,2.04909061543543,-0.25253413624496 +-161.04269,54.8445254,13.719616,-451678.354640893,560779.79659344,104.772483825684,110,2.02024723978751,-0.357301509317248 +-160.98536,54.8480337,13.719616,-447974.162939733,560779.769936749,89.0802612304688,13,1.94978148194513,-0.613253254730478 +-160.92802,54.8515135,13.719616,-444269.998973256,560779.75661023,79.2678604125977,13,1.89909713593349,-0.797353266197365 +-160.87068,54.8549646,13.719616,-440566.498639017,560779.801001832,83.2832336425781,13,1.92055757920498,-0.719402810814972 +-160.81332,54.8583872,13.719616,-436862.376383683,560779.792213198,83.5096817016602,13,1.92173682836816,-0.715119441263095 +-160.75595,54.8617812,13.719616,-433158.26693149,560779.786281963,90.8578033447266,13,1.95836223273399,-0.582085518675216 +-160.69857,54.8651465,13.719616,-429454.166028526,560779.772356439,85.9289779663086,13,1.93413964635279,-0.6700688662262 +-160.64118,54.8684832,13.719616,-425750.067157929,560779.76174177,78.218017578125,13,1.89330680463847,-0.818385402185992 +-160.58378,54.8717913,13.719616,-422045.96494035,560779.754683552,76.7140350341797,13,1.88487482653418,-0.849012753386934 +-160.52638,54.8750707,13.719616,-418342.494023704,560779.803355486,73.9560928344727,13,1.86897395893317,-0.906769243073238 +-160.46896,54.8783215,13.719616,-414638.37003777,560779.792558029,73.9706192016602,13,1.8690592541587,-0.906459426468462 +-160.41153,54.8815436,13.719616,-410934.227606728,560779.775044491,70.7277984619141,13,1.84959014004593,-0.977176805964441 +-160.35409,54.8847371,13.719616,-407230.060250028,560779.762184602,68.3814926147461,13,1.83493857623936,-1.03039546768258 +-160.29665,54.8879019,13.719616,-403526.502568187,560779.803964872,65.159797668457,13,1.81397972708507,-1.10652399006207 +-160.18172,54.8941455,9.976261171,-396117.998817725,560779.758871814,22.5604000091553,13,1.35334679567605,-2.77967427466795 +-160.12425,54.8972242,13.719616,-392414.320818267,560779.781989614,51.010311126709,13,1.7076579724275,-1.49271495022849 +-160.06676,54.9002743,13.719616,-388709.9519031,560779.751752042,54.0075836181641,13,1.73245474671697,-1.40264598830508 +-160.00927,54.9032957,13.719616,-385006.165551418,560779.775058429,53.7418823242188,13,1.7303128736473,-1.41042588264559 +-159.95177,54.9062883,13.719616,-381302.318389292,560779.782108142,59.0900535583496,13,1.77151438361793,-1.26077023835048 +-159.89426,54.9092523,13.719616,-377598.402979994,560779.7954587,56.7696571350098,13,1.75411627127627,-1.32396514829107 +-159.83674,54.9121875,13.719616,-373894.415869531,560779.7933352,54.732738494873,13,1.73824717815271,-1.38160622400595 +-159.77921,54.915094,13.719616,-370190.350622801,560779.787234082,51.7633361816406,13,1.71402225913254,-1.46959804436749 +-159.72167,54.9179718,13.719616,-366486.201798848,560779.777577737,47.6133308410645,13,1.6777285640684,-1.60142710409236 +-159.66412,54.9208208,13.719616,-362781.964902883,560779.753710067,43.4398803710938,13,1.63788862058067,-1.74613715029181 +-159.60657,54.9236411,13.719616,-359078.27246002,560779.781235467,43.9847297668457,13,1.64330192809882,-1.7264744722741 +-159.54901,54.9264326,13.719616,-355374.481014684,560779.794335825,45.5463409423828,13,1.65845349278295,-1.67143966465422 +-159.49143,54.9291954,13.719616,-351669.945232137,560779.751618933,39.9620628356934,13,1.60164789834863,-1.87777379757053 +-159.43385,54.9319294,12.05974118,-347965.938446253,560779.748938578,25.7283325195312,13,1.41041164003728,-2.57239847201981 +-159.37627,54.9346347,13.719616,-344262.454275143,560779.796208902,25.0375957489014,13,1.39859262313598,-2.6153285148886 +-159.26107,54.9399589,10.71984405,-336854.47884859,560779.799769852,17.0963764190674,13,1.23290407132986,-3.21715662726943 +-159.20345,54.9425778,13.20496337,-333149.976620085,560779.758221917,48.3446273803711,13,1.68434821722553,-1.57738263438854 +-159.14583,54.9451679,13.719616,-329445.975979635,560779.755392533,67.7071838378906,13,1.83063475045229,-1.04602819137539 +-159.08821,54.9477293,13.719616,-325742.470584011,560779.801260835,80.5981979370117,13,1.90632533169639,-0.771098396054036 +-159.03057,54.9502618,13.719616,-322038.178778786,560779.775539137,84.9404144287109,13,1.92911437560525,-0.688322083936339 +-158.97293,54.9527655,13.719616,-318334.372082531,560779.787444533,91.0500183105469,13,1.95928003746942,-0.578751789908576 +-158.91528,54.9552404,13.719616,-314630.406061078,560779.788517823,79.7236251831055,13,1.90158703866396,-0.788309228791321 +-158.85762,54.9576865,13.719616,-310926.275216016,560779.779361468,73.222770690918,13,1.86464615821132,-0.922489050572316 +-158.79995,54.9601038,13.719616,-307221.974047185,560779.760590215,78.3902816772461,13,1.89426222498601,-0.814915042779601 +-158.74228,54.9624922,13.719616,-303518.136784455,560779.767430638,92.3984069824219,13,1.96566448372327,-0.555561658812202 +-158.6846,54.9648518,13.719616,-299814.118173181,560779.764805489,117.152084350586,120,2.0687500198976,-0.181125567885657 +-158.62691,54.9671826,13.719616,-296109.91270807,560779.753366341,139.052276611328,120,2.14317810367586,0.0892184762870959 +-158.56922,54.9694846,13.719616,-292406.153819693,560779.777806788,162.841842651367,120,2.21176600803304,0.338349321849323 +-158.51152,54.9717576,13.719616,-288702.198573178,560779.771445372,181.326843261719,120,2.25846210093772,0.507962859671006 +-158.45381,54.9740019,13.719616,-284998.039162407,560779.768287114,191.910461425781,120,2.28309864964769,0.597449836556685 +-158.3961,54.9762172,13.719616,-281294.31125103,560779.778068682,185.846008300781,120,2.2691532375245,0.54679611930837 +-158.33838,54.9784038,13.719616,-277590.368150072,560779.791351917,174.550354003906,120,2.24192073393958,0.447879893357565 +-158.28065,54.9805614,13.719616,-273886.20652458,560779.775537562,162.639892578125,120,2.21122707878331,0.336391776988582 +-158.22292,54.9826902,13.719616,-270182.458322815,560779.794261989,156.358596801758,120,2.19412176431848,0.274260392509516 +-158.16518,54.9847901,13.719616,-266478.479786856,560779.795366371,145.247253417969,120,2.16210792876152,0.157977004108223 +-158.10743,54.9868611,13.719616,-262774.265368109,560779.779611358,127.019660949707,120,2.10387094915358,-0.0535563283166881 +-158.04968,54.9889032,13.719616,-259070.448454011,560779.786780139,91.4500045776367,21,1.96118373155155,-0.571837029633878 +-157.99192,54.9909165,13.719616,-255366.383886711,560779.78864467,84.6395263671875,21,1.92757322443718,-0.693919984867104 +-157.93415,54.9929008,13.719616,-251662.067460335,560779.763779274,84.3926162719727,21,1.92630445074158,-0.698528533073596 +-157.87638,54.9948563,13.719616,-247958.131230136,560779.772555946,84.0312118530273,21,1.92444062675027,-0.705298473798365 +-157.8186,54.9967828,13.719616,-244253.932011191,560779.755119072,82.3742370605469,21,1.91579140524178,-0.736714915050822 +-157.76082,54.9986805,13.719616,-240550.101894605,560779.77075243,74.770866394043,21,1.87373241298548,-0.889485179757263 +-157.70303,55.0005492,13.719616,-236845.997654024,560779.760738409,69.9412155151367,21,1.84473317568454,-0.994818686840659 +-157.64524,55.0023891,13.719616,-233142.251416495,560779.783272543,72.9460601806641,21,1.86300184060229,-0.928461681463309 +-157.58744,55.0042,13.719616,-229438.219914296,560779.780775325,89.4365692138672,21,1.95151513132876,-0.606956145336319 +-157.52963,55.0059819,13.719616,-225733.897555763,560779.754130104,93.8048706054688,21,1.97222538872194,-0.531730579188292 +-157.47182,55.007735,13.719616,-222029.916522035,560779.759900005,92.6797790527344,21,1.96698498976735,-0.550765203950162 +-157.41401,55.0094591,13.719616,-218326.272421002,560779.775087825,100.381576538086,122,2.00165401219097,-0.424837418983375 +-157.35619,55.0111543,13.719616,-214622.320157277,560779.777742335,107.789283752441,122,2.03257558609635,-0.312521436663158 +-157.29836,55.0128206,13.719616,-210918.05416316,560779.76879851,136.439331054688,122,2.13493958144798,0.0592938120470829 +-157.24053,55.0144579,13.719616,-207214.108350283,560779.76928626,184.090377807617,122,2.26503108902403,0.531823299376324 +-157.1827,55.0160663,13.719616,-203510.476586192,560779.789610706,274.134704589844,221,2.43796401933297,1.15996506223092 +-157.12486,55.0176457,13.719616,-199806.514885715,560779.787864525,437.409637451172,320,2.64088834762195,1.89704414294624 +-157.06701,55.0191962,13.719616,-196102.217133439,560779.776152095,625.421569824219,320,2.79617285531129,2.46108179748509 +-157.00916,55.0207177,13.719616,-192398.217197619,560779.77332056,648.081909179688,420,2.81162989855068,2.51722619040994 +-156.95131,55.0222103,13.719616,-188694.508979969,560779.789827144,649.928894042969,420,2.81286584492904,2.52171550043035 +-165.07168,54.4900393,12.1523959,-714662.045036606,557075.747301598,60.5652275085449,10,1.78222335295397,-1.22187220507781 +-165.01535,54.495551,13.719616,-710958.284080065,557075.785614674,82.3781814575195,10,1.91581220044291,-0.736639380944771 +-164.959,54.5010348,13.66404667,-707254.267368669,557075.782034662,56.4070091247559,11,1.75133307269029,-1.33407451995932 +-164.22503,54.5697795,12.93685,-659102.19656817,557075.769257476,21.7623691558838,11,1.33770617298014,-2.83648548057769 +-164.16846,54.5748715,13.719616,-655397.934373077,557075.737017621,44.6071472167969,11,1.64940444947744,-1.70430837279392 +-164.11188,54.5799353,13.719616,-651693.986089076,557075.738870653,64.8496017456055,11,1.81190731333888,-1.11405158831402 +-164.05529,54.5849711,13.719616,-647990.343270823,557075.796382693,59.3050155639648,11,1.77309142421826,-1.2550419767579 +-163.99868,54.5899788,13.719616,-644286.363055296,557075.801129361,55.2459907531738,11,1.74230076639422,-1.3668824345035 +-163.94205,54.5949584,13.719616,-640582.040374676,557075.754380181,56.9101066589355,11,1.75518939954865,-1.32006724010448 +-163.88541,54.5999098,13.719616,-636878.011303062,557075.742312439,59.4308242797852,11,1.77401175377629,-1.2516990771149 +-163.82876,54.6048332,13.719616,-633174.267456768,557075.786547719,63.9287567138672,11,1.80569625835914,-1.13661191281204 +-163.77209,54.6097284,13.719616,-629470.167553361,557075.769924467,55.4240798950195,11,1.74369849204665,-1.36180549598327 +-163.71541,54.6145955,13.22224999,-625766.344357226,557075.798984468,33.5367851257324,11,1.52552142830367,-2.15428686543166 +-163.65871,54.6194344,9.425996221,-622062.154901352,557075.768701547,11.3604764938354,11,1.05539654742284,-3.86191461979125 +-163.48853,54.6337821,12.19253921,-610949.892616265,557075.725161971,30.3518657684326,11,1.48218539287518,-2.31169571544392 +-163.43178,54.6385084,13.6880817,-607246.102288716,557075.765035322,44.4845542907715,11,1.64820924354926,-1.7086497018708 +-163.37501,54.6432064,13.719616,-603541.921694712,557075.737971985,77.6865921020508,11,1.89034607055694,-0.829139633447745 +-163.31823,54.6478762,13.719616,-599837.983613817,557075.746692317,57.9366569519043,11,1.76295343202709,-1.29186605806729 +-163.26144,54.6525178,13.719616,-596134.282911438,557075.790919727,56.7980728149414,11,1.75433360014701,-1.3231757478007 +-163.20463,54.6571311,13.719616,-592430.176491808,557075.770162313,54.5254058837891,11,1.73659890712435,-1.38759321484434 +-163.14781,54.6617162,11.44280377,-588726.297153343,557075.785504752,17.7264881134033,11,1.24862270378806,-3.16006206763689 +-163.03412,54.6708017,11.30158633,-581317.921659693,557075.737436428,33.3394622802734,12,1.52295859097509,-2.16359582211565 +-162.97726,54.675302,13.719616,-577614.056183505,557075.751750899,74.3201370239258,12,1.87110650169441,-0.89902323907612 +-162.92039,54.6797741,13.719616,-573910.397156899,557075.802368855,80.5208282470703,12,1.90590823344566,-0.772613415952404 +-162.8635,54.6842179,13.719616,-570206.301409206,557075.79220338,76.0801467895508,12,1.88127134186088,-0.862101638257264 +-162.8066,54.6886333,13.719616,-566502.404719569,557075.797009153,72.1865768432617,12,1.85845644764059,-0.944971846084506 +-162.74968,54.6930205,13.719616,-562798.059450494,557075.753918657,103.303276062012,11,2.01411409454086,-0.379578843427026 +-162.69275,54.6973794,13.719616,-559093.9013846,557075.737594888,86.0368804931641,11,1.93468465544432,-0.668089237644676 +-162.63581,54.7017099,13.719616,-555389.926768493,557075.736846683,121.305221557617,110,2.08387949538309,-0.126170994540131 +-162.57886,54.7060121,13.719616,-551686.128941182,557075.762558254,105.727317810059,13,2.02418721475613,-0.34299039565039 +-162.5219,54.710286,13.719616,-547982.502700538,557075.814594388,56.9542846679688,13,1.75552640159615,-1.31884315247799 +-162.46492,54.7145315,13.68553836,-544278.404760754,557075.799837916,48.7436752319336,13,1.6879182715203,-1.56441517819501 +-161.60878,54.7748065,13.719616,-488718.149516723,557075.76904366,118.72200012207,13,2.07453120460157,-0.160126654926431 +-161.55161,54.7785973,13.719616,-485014.107610752,557075.76780312,69.9615173339844,13,1.84485921994087,-0.994360858125068 +-161.49443,54.7823595,13.719616,-481310.146553506,557075.763641423,95.8940505981445,13,1.9817916637656,-0.496983137743006 +-161.43724,54.7860933,13.719616,-477606.258517697,557075.778748584,107.330535888672,13,2.03072329774686,-0.319249476644242 +-161.38004,54.7897986,13.719616,-473902.439452073,557075.802154812,143.051879882812,13,2.15549356935811,0.133951762828913 +-161.32282,54.7934754,13.719616,-470198.04454483,557075.763157555,131.559143066406,13,2.11912103596642,0.00183633979564911 +-161.2656,54.7971236,13.719616,-466494.348682561,557075.792964824,73.1450729370117,13,1.86418507730569,-0.924163828027146 +-161.20836,54.8007433,13.719616,-462790.066318941,557075.761714139,78.2888488769531,13,1.89369990744634,-0.81695754058509 +-161.15112,54.8043345,13.719616,-459086.471120402,557075.809468359,88.346305847168,13,1.94618839443438,-0.62630437413878 +-161.09386,54.8078971,13.719616,-455382.279956309,557075.786493436,104.923416137695,13,2.02087242207842,-0.355030668791857 +-161.03659,54.8114311,13.719616,-451678.126964244,557075.762628971,109.101181030273,110,2.03782945189132,-0.293437896493249 +-160.97931,54.8149366,13.719616,-447974.005616602,557075.749108423,93.815559387207,13,1.97227487244749,-0.531550840173049 +-160.92202,54.8184136,13.719616,-444269.9105794,557075.746112374,94.7947158813477,13,1.97678412924173,-0.515171932426326 +-160.86473,54.821862,13.719616,-440566.477159884,557075.80910246,96.8405075073242,13,1.98605705676157,-0.481490012917272 +-160.80742,54.8252817,13.719616,-436862.422138884,557075.793972329,101.482727050781,13,2.00639212909752,-0.407627225985603 +-160.7501,54.8286729,13.719616,-433158.377354671,557075.789972748,100.896141052246,110,2.00387455620951,-0.416771769301672 +-160.69277,54.8320355,13.719616,-429454.338583411,557075.786258332,99.8199768066406,110,1.99921746462098,-0.433687655217523 +-160.63543,54.8353695,13.719616,-425750.300450561,557075.783065514,95.3669052124023,110,1.97939768940822,-0.505678735917312 +-160.57808,54.8386749,13.719616,-422046.25757923,557075.780642565,92.5338516235352,13,1.96630063959137,-0.553250959122298 +-160.52072,54.8419517,13.719616,-418342.204590229,557075.779249612,86.2567291259766,13,1.93579298558048,-0.664063466241226 +-160.46335,54.8451998,13.719616,-414638.137183538,557075.768081575,79.6449737548828,13,1.90115837349062,-0.789866263054102 +-160.40597,54.8484193,13.719616,-410934.048874788,557075.758497438,77.2583923339844,13,1.88794566669071,-0.837858585433358 +-160.34858,54.8516102,13.719616,-407229.934277944,557075.750793012,84.3018112182617,13,1.92583690551023,-0.700226790804565 +-160.29119,54.8547724,13.719616,-403526.428552788,557075.794957857,77.8495407104492,13,1.89125605470111,-0.825834311300783 +-160.23378,54.857906,12.59964655,-399822.246246364,557075.780308132,32.2096862792969,13,1.50798649483417,-2.21797874876119 +-160.17636,54.8610109,13.57650822,-396118.022494881,557075.757413127,59.0882034301758,13,1.77150078550814,-1.26081963056653 +-160.11894,54.8640872,13.719616,-392414.390345971,557075.796785038,59.9099426269531,13,1.77749890368635,-1.2390327533099 +-160.0615,54.8671347,13.719616,-388710.067440972,557075.757876585,60.6097145080566,13,1.78254223834316,-1.22071392232533 +-160.00406,54.8701537,13.719616,-385006.324299124,557075.791923453,59.7799110412598,13,1.77655526442827,-1.24246032043669 +-159.94661,54.8731439,13.719616,-381302.519038485,557075.806962173,55.7405586242676,13,1.74617131683909,-1.35282349052265 +-159.88914,54.8761054,13.719616,-377598.005717147,557075.757607456,58.6969413757324,13,1.76861547129446,-1.27129991534129 +-159.83167,54.8790382,13.719616,-373894.057891394,557075.75853321,54.2573852539062,13,1.73445886061684,-1.39536647458971 +-159.77419,54.8819424,13.719616,-370190.029663086,557075.763825024,48.245475769043,13,1.68345659352098,-1.58062126617823 +-159.7167,54.8848178,13.719616,-366485.917536471,557075.75173189,43.5517654418945,13,1.63900576453616,-1.74207936458082 +-159.65921,54.8876645,13.719616,-362782.35459028,557075.788404855,42.7206001281738,13,1.63063734492227,-1.77247585320323 +-159.6017,54.8904825,13.719616,-359078.056391512,557075.764481536,45.2144508361816,13,1.65527726037318,-1.68297664735348 +-159.54419,54.8932717,13.719616,-355374.297414409,557075.778026938,41.7804870605469,13,1.6209734985087,-1.80757770171372 +-159.48667,54.8960323,13.719616,-351670.430851412,557075.797070112,40.7431373596191,13,1.61005446809834,-1.84723873676571 +-159.42914,54.8987641,13.719616,-347966.453100797,557075.799911773,40.748722076416,13,1.61011399334929,-1.84702252406406 +-159.3716,54.9014671,13.69736222,-344262.358683436,557075.787046715,32.5801086425781,13,1.51295252818592,-2.19994069818058 +-159.14136,54.9119917,13.719616,-329445.978522073,557075.754640508,45.8002433776855,13,1.66086778580529,-1.66267026328924 +-159.08379,54.914551,13.719616,-325742.495011652,557075.801372753,75.2862701416016,13,1.8767157817064,-0.878648733024669 +-159.0262,54.9170814,13.719616,-322038.22332394,557075.773805643,82.5579528808594,13,1.91675891558681,-0.733200641322727 +-158.96861,54.9195831,13.719616,-318334.435264421,557075.792257764,74.4069061279297,13,1.87161324675631,-0.897182596371863 +-158.91101,54.922056,13.719616,-314630.486695073,557075.797173641,85.9234161376953,13,1.93411153535103,-0.670170973408285 +-158.8534,54.9245001,13.719616,-310926.372120136,557075.789157776,80.2163772583008,13,1.90426304442877,-0.778589212045436 +-158.79578,54.9269154,13.719616,-307222.086042105,557075.768826934,64.6085205078125,13,1.81028979609899,-1.1199268726147 +-158.73816,54.9293019,13.719616,-303518.262457019,557075.782513067,82.1646423339844,13,1.91468496908819,-0.740733806968969 +-158.68053,54.9316596,13.719616,-299814.25636866,557075.784039008,108.929260253906,120,2.03714455431889,-0.295925639965529 +-158.62289,54.9339884,13.719616,-296110.063048616,557075.762953973,131.221954345703,120,2.11800650160627,-0.00221196712018293 +-158.56525,54.9362885,13.719616,-292406.314929783,557075.786161394,157.145690917969,120,2.19630247675541,0.282181362517713 +-158.5076,54.9385597,13.719616,-288702.368549743,557075.786984839,158.934829711914,120,2.20121908093388,0.300039872232459 +-158.44994,54.9408021,13.719616,-284998.217626695,557075.777218998,188.729385375977,120,2.27583952556537,0.571082625929405 +-158.39228,54.9430157,13.719616,-281294.496146723,557075.799923102,185.479019165039,120,2.26829479062932,0.543677995159946 +-158.3346,54.9452004,13.719616,-277589.920334529,557075.75943357,177.8427734375,120,2.250036222516,0.477357664258178 +-158.27693,54.9473563,13.719616,-273886.402418284,557075.792980518,179.218780517578,120,2.25338351786955,0.48951599639546 +-158.21924,54.9494833,13.719616,-270182.019105002,557075.764798153,155.877380371094,120,2.19278309855805,0.269397976374369 +-158.16155,54.9515815,13.719616,-266478.043143781,557075.768670585,149.056549072266,120,2.1733510623107,0.198815274268648 +-158.10386,54.9536508,13.719616,-262774.469705132,557075.792578586,130.627151489258,120,2.11603345654388,-0.00937862994991759 +-158.04615,54.9556913,13.719616,-259070.013573347,557075.768714472,88.763671875,21,1.9482352593336,-0.618869576591426 +-157.98844,54.9577029,13.719616,-255365.948887222,557075.765333669,91.033821105957,21,1.95920277244012,-0.579032438548645 +-157.93073,54.9596856,13.719616,-251662.270096466,557075.781562491,90.886604309082,21,1.95849987768449,-0.581585552927211 +-157.87301,54.9616394,13.719616,-247958.332154071,557075.779202826,91.2514877319336,21,1.96023995376963,-0.57526509991881 +-157.81528,54.9635644,13.719616,-244254.128867735,557075.770192449,90.3963012695312,21,1.9561506608836,-0.590118578881273 +-157.75755,54.9654605,13.719616,-240550.294836684,557075.780477356,81.1972351074219,21,1.90954124108805,-0.759417295231609 +-157.69981,54.9673277,13.719616,-236846.185009733,557075.773569895,87.2643890380859,21,1.94083705241754,-0.645741975769034 +-157.64207,54.969166,13.719616,-233142.433324904,557075.785437657,98.9827117919922,21,1.99555934784011,-0.446974979496092 +-157.58432,54.9709754,13.719616,-229438.394728343,557075.780733295,96.7749328613281,21,1.98576287869453,-0.482558551623519 +-157.52656,54.972756,13.719616,-225734.063069298,557075.771459606,95.1997756958008,21,1.97863592512617,-0.508445681218895 +-157.4688,54.9745076,13.719616,-222030.073473228,557075.76971642,97.2426910400391,21,1.98785696876106,-0.474952218789086 +-157.41104,54.9762303,13.719616,-218326.419777164,557075.785857648,113.620948791504,122,2.05545841153158,-0.229404483273782 +-157.35327,54.9779241,13.719616,-214622.45692212,557075.786816761,131.529159545898,122,2.11902204503879,0.00147677649170347 +-157.29549,54.979589,13.719616,-210918.179343169,557075.773530157,176.754928588867,122,2.24737153239316,0.467678749153729 +-157.23771,54.981225,13.719616,-207214.220969444,557075.778148506,251.280410766602,221,2.40015863332965,1.02264510953538 +-157.17992,54.982832,13.719616,-203509.937271171,557075.758196617,456.347381591797,320,2.65929556299918,1.96390440313869 +-165.17474,54.4461029,9.133882319,-722070.286513809,553371.788641016,142.218383789062,10,2.15295573888391,0.124733638177688 +-165.11848,54.451666,13.7166744,-718365.97775902,553371.738856676,99.6219024658203,10,1.99835483113777,-0.436820986248645 +-165.06221,54.4572012,13.719616,-714662.060769138,553371.751745465,58.2451248168945,10,1.76525958027785,-1.28348946938029 +-165.00592,54.4627085,13.719616,-710957.89054659,553371.719660915,77.1595077514648,10,1.88738944834582,-0.839878929222534 +-164.94962,54.468188,13.719616,-707254.100370603,553371.761163218,67.3375396728516,11,1.82825724442474,-1.05466397187522 +-164.27276,54.531762,13.719616,-662805.942407672,553371.737660725,31.8572235107422,11,1.50320792254772,-2.23533588724587 +-164.21626,54.5368779,13.719616,-659102.199553933,553371.778081579,61.5510330200195,11,1.78923534615652,-1.19640264434404 +-164.15974,54.5419657,13.719616,-655398.132120845,553371.761183691,67.924919128418,11,1.83202913001812,-1.04096340679675 +-164.10321,54.5470255,13.719616,-651694.373419673,553371.797334583,75.0098114013672,11,1.87511807350885,-0.884452065229494 +-164.04666,54.5520573,13.719616,-647990.278366247,553371.788544737,70.0418014526367,11,1.84535730746964,-0.992551662052239 +-163.9901,54.557061,13.719616,-644286.483646285,553371.822097025,69.3338317871094,11,1.8409452024779,-1.00857768672237 +-163.93352,54.5620366,13.719616,-640582.344140935,553371.801134438,64.137809753418,11,1.8071141250928,-1.13146181613592 +-163.87693,54.5669841,13.719616,-636878.494834082,553371.822840629,74.7910690307617,11,1.87384974088278,-0.889059011345531 +-163.82032,54.5719035,13.719616,-633174.290600297,553371.791495753,81.4521942138672,11,1.9109027881183,-0.754471767793514 +-163.7637,54.5767948,13.719616,-629470.366416912,553371.803189719,82.241569519043,11,1.91509138991671,-0.739257570515734 +-163.70706,54.5816579,13.719616,-625766.078772348,553371.752333312,76.4422760009766,11,1.88333360930853,-0.854610894257666 +-163.65041,54.586493,13.719616,-622062.059387386,553371.755934451,74.9837493896484,11,1.87496715252356,-0.885000253325195 +-163.59375,54.5912999,13.719616,-618358.306407985,553371.791643919,34.7000007629395,11,1.54032948433959,-2.10049977926921 +-163.53707,54.5960786,13.719616,-614654.174664423,553371.766580711,77.6824645996094,11,1.89032299580096,-0.829223447547639 +-163.48038,54.6008292,13.719616,-610950.297506992,553371.785108691,97.1465454101562,11,1.98742736143624,-0.476512675214954 +-163.42367,54.6055517,13.719616,-607246.029787763,553371.75548863,97.9310836791992,11,1.99092056031934,-0.463824379813311 +-163.36695,54.6102459,13.719616,-603542.009589772,553371.747952269,78.7620620727539,11,1.89631707789644,-0.807451230495507 +-163.31022,54.614912,13.719616,-599838.228646183,553371.784244673,67.2030944824219,11,1.82738927135291,-1.05781669781631 +-163.25347,54.6195498,13.719616,-596134.04489014,553371.752296721,63.2880325317383,11,1.80132159474406,-1.15250193971532 +-163.19671,54.6241595,13.719616,-592430.090139189,553371.76476099,71.5537338256836,11,1.85463230109483,-0.958862237858779 +-163.13994,54.6287409,13.719616,-588726.362335675,553371.799349182,96.9762878417969,11,1.98666555572631,-0.479279770994447 +-163.08315,54.6332941,13.719616,-585022.214739576,553371.778748524,64.443115234375,11,1.80917652641505,-1.12397058586556 +-163.02635,54.637819,13.719616,-581318.283766649,553371.780913403,75.5737762451172,11,1.87837112344104,-0.872636059362866 +-162.96953,54.6423158,13.719616,-577613.921191416,553371.740696535,59.5101661682129,11,1.7745911629322,-1.24959449768082 +-162.91271,54.6467842,13.719616,-573910.406463492,553371.799325636,80.3834915161133,11,1.90516686616616,-0.775306273518834 +-162.85587,54.6512244,13.719616,-570206.451307759,553371.805259276,73.8282165527344,11,1.86822237742069,-0.909499201649318 +-162.79901,54.6556364,13.719616,-566502.050567318,553371.759986624,72.1594314575195,11,1.85829310275125,-0.945565161345846 +-162.74215,54.66002,13.719616,-562798.482109213,553371.812436742,79.7093734741211,11,1.90150939553313,-0.788591250804025 +-162.68527,54.6643754,13.719616,-559094.457705962,553371.814456244,44.5543479919434,11,1.64889009258764,-1.70617666382976 +-162.62837,54.6687024,13.719616,-555389.975074925,553371.745502031,124.378852844238,110,2.09474654696444,-0.0866987614313223 +-162.57147,54.6730011,13.719616,-551686.307664662,553371.784277424,133.900405883789,110,2.12678189346326,0.0296627608506201 +-162.51455,54.6772716,13.719616,-547982.168746536,553371.774985544,74.7381286621094,13,1.8735422195252,-0.890176016691602 +-162.45762,54.6815137,13.70860369,-544278.196025516,553371.779065196,50.4253997802734,13,1.70264935005146,-1.51090769630142 +-161.65932,54.7379238,13.719616,-492422.336595821,553371.79065389,125.38892364502,13,2.09825917435509,-0.0739398961448234 +-161.60221,54.74174,13.719616,-488718.305990917,553371.791265775,88.5379638671875,13,1.94712953016358,-0.622885900543454 +-161.54509,54.7455277,13.719616,-485014.358783523,553371.797102433,86.6631317138672,13,1.93783437892264,-0.656648542950836 +-161.48796,54.7492869,13.719616,-481310.489667216,553371.808230642,95.1116256713867,13,1.97823360480647,-0.509907023453704 +-161.43081,54.7530177,13.719616,-477606.052037415,553371.763870677,114.192726135254,13,2.05763844103828,-0.221485993863052 +-161.37366,54.7567199,13.719616,-473902.323183152,553371.786387566,133.562789916992,13,2.12568548220698,0.0256802822208784 +-161.31649,54.7603937,13.719616,-470198.01520865,553371.754725634,134.332855224609,13,2.12818224571165,0.0347492399170747 +-161.25932,54.764039,13.719616,-466494.404145792,553371.800099666,74.3789596557617,13,1.87145009955506,-0.897775193573644 +-161.20213,54.7676557,13.719616,-462790.205773814,553371.770526851,70.1025695800781,13,1.84573393713921,-0.991183635591533 +-161.14493,54.771244,13.719616,-459086.052405491,553371.759070019,80.7694396972656,13,1.90724707016337,-0.767750378851637 +-161.08772,54.7748037,13.719616,-455381.94111607,553371.743750213,95.2453079223633,13,1.97884359018894,-0.507691382437415 +-161.03051,54.7783349,13.719616,-451678.50542738,553371.80380298,111.211517333984,13,2.04614976616314,-0.263216140203862 +-160.97328,54.7818376,13.719616,-447974.45990425,553371.802817257,101.734756469727,110,2.00746934981835,-0.403714452858118 +-160.91604,54.7853117,13.719616,-444270.44042498,553371.79847825,98.6143646240234,13,1.99394018089013,-0.452856256014699 +-160.85879,54.7887573,13.719616,-440566.440479661,553371.802047435,90.6582260131836,13,1.95740721659535,-0.585554409879509 +-160.80153,54.7921743,13.719616,-436862.455869699,553371.802661139,104.993156433105,110,2.02116099221089,-0.353982499704607 +-160.74426,54.7955627,13.719616,-433158.481227709,553371.800534924,111.289894104004,110,2.0464557291673,-0.262104795242216 +-160.68698,54.7989226,13.719616,-429454.510065261,553371.806968727,107.828796386719,110,2.03273475752774,-0.311943280592316 +-160.62968,54.8022539,13.719616,-425749.898095031,553371.747022805,105.92472076416,110,2.02499732779935,-0.340047833848134 +-160.57238,54.8055566,13.719616,-422045.920048631,553371.74972254,103.161323547363,110,2.01351690544757,-0.381748004668578 +-160.51507,54.8088307,13.719616,-418341.930496319,553371.750664675,100.29866027832,13,2.00129513204715,-0.426140974100327 +-160.45775,54.8120762,13.719616,-414637.924059074,553371.750123881,91.9251251220703,13,1.96343422967267,-0.563662578101876 +-160.40042,54.8152931,13.719616,-410933.895355606,553371.748386697,86.3928909301758,13,1.93647800686754,-0.661575273402114 +-160.34309,54.8184814,13.719616,-407230.479055384,553371.807071152,90.2540588378906,13,1.95546674178282,-0.592602768265269 +-160.28574,54.821641,13.719616,-403526.390718415,553371.79221098,82.3864517211914,13,1.91585579875415,-0.736481019434139 +-160.22838,54.824772,13.719616,-399822.263938776,553371.777083365,77.8996276855469,13,1.89153538200506,-0.824819714804899 +-160.17101,54.8278744,13.719616,-396118.093326277,553371.762022436,71.6254730224609,13,1.8550675031132,-0.957281459909072 +-160.11364,54.8309482,13.719616,-392414.51354156,553371.806462909,66.7772521972656,13,1.82462854439614,-1.0678444461132 +-160.05625,54.8339933,13.719616,-388710.24009761,553371.780944255,61.7261085510254,13,1.79046889825193,-1.19192203104271 +-159.99885,54.8370097,13.719616,-385005.907622055,553371.745480074,62.4918212890625,13,1.79582318212082,-1.17247374376614 +-159.94145,54.8399975,13.719616,-381302.149746011,553371.768950067,59.1726875305176,13,1.77212129469813,-1.25856576407753 +-159.88404,54.8429566,13.719616,-377598.322000377,553371.782131083,59.4863815307617,13,1.77441755223279,-1.2502251012945 +-159.82662,54.8458871,13.719616,-373894.417978216,553371.796513182,45.7336578369141,13,1.66023593820241,-1.66496531413016 +-159.76919,54.8487888,12.87717919,-370190.434205784,553371.790338436,38.037353515625,13,1.58021029287255,-1.95564129956146 +-159.71175,54.8516619,12.38494833,-366486.363306376,553371.786208828,27.7791309356689,13,1.44371865480162,-2.45141788762721 +-159.6543,54.8545063,13.719616,-362782.20081736,553371.773476566,43.4972457885742,13,1.63846175863986,-1.74405534927092 +-159.59684,54.857322,13.719616,-359077.941298858,553371.752592906,34.317512512207,13,1.53551580069841,-2.11798445221608 +-159.53938,54.860109,13.719616,-355374.219362023,553371.777532397,45.3168525695801,13,1.65625973880983,-1.67940800524431 +-159.48191,54.8628673,13.719616,-351670.389509995,553371.794143668,40.9660720825195,13,1.61242432483511,-1.83863074067331 +-159.42443,54.8655968,13.719616,-347966.447205072,553371.791821147,44.3670959472656,13,1.64706100285779,-1.71282043980274 +-159.36694,54.8682977,13.719616,-344262.385173745,553371.79324953,30.1522846221924,13,1.47932022397936,-2.32210282667414 +-159.19442,54.8762278,13.47781047,-333150.075253346,553371.764443856,21.5981826782227,13,1.33441721013132,-2.84843193240806 +-159.1369,54.8788137,13.719616,-329446.125206631,553371.768596765,53.4571762084961,13,1.72800601410144,-1.4188050549594 +-159.07937,54.8813709,13.719616,-325742.029045805,553371.766969128,69.8916549682617,13,1.844425324278,-0.99593689101874 +-159.02184,54.8838993,13.719616,-322038.422205809,553371.797526317,77.8742828369141,13,1.89139406016283,-0.825333036073139 +-158.96429,54.8863989,13.719616,-318334.019091054,553371.763309397,73.1901016235352,13,1.86445235017103,-0.923193016692996 +-158.90674,54.8888698,13.719616,-314630.0934946,553371.772438447,76.153938293457,13,1.8816923677494,-0.860572352057398 +-158.84918,54.8913119,13.719616,-310926.000711173,553371.76592974,77.7538909912109,13,1.89072213138028,-0.827773673198905 +-158.79162,54.8937252,13.719616,-307222.375298941,553371.790662747,82.0230178833008,13,1.91393574429739,-0.743455205259191 +-158.73404,54.8961097,13.719616,-303517.93165529,553371.754189346,88.6941223144531,13,1.94789484045204,-0.620106075134466 +-158.67646,54.8984655,13.719616,-299813.943604827,553371.760219499,102.379234313965,120,2.01021187717297,-0.393752810710895 +-158.61888,54.9007924,13.719616,-296110.407223485,553371.78553006,129.443496704102,120,2.11208023618093,-0.023737854669553 +-158.56128,54.9030906,13.719616,-292406.035346946,553371.763262903,148.802658081055,120,2.17261068913744,0.196126027579829 +-158.50368,54.90536,13.719616,-288702.103361104,553371.771612189,161.135986328125,120,2.2071925417751,0.32173718700325 +-158.44607,54.9076005,13.719616,-284997.966452668,553371.755576806,178.16813659668,120,2.25083003787393,0.480241028215622 +-158.38846,54.9098123,13.719616,-281294.257669265,553371.780428881,182.47119140625,120,2.26119430769169,0.517887014450844 +-158.33084,54.9119952,13.719616,-277590.3329294,553371.781200827,176.259704589844,120,2.24615303791189,0.463252829404809 +-158.27321,54.9141493,13.719616,-273886.185978789,553371.76972767,179.680419921875,120,2.25450075388588,0.493574116497701 +-158.21558,54.9162746,13.719616,-270182.45135924,553371.787434169,155.941635131836,120,2.19296208371953,0.270048101568321 +-158.15794,54.9183711,13.719616,-266478.483505012,553371.793275264,156.7099609375,120,2.19509660235692,0.277801282511607 +-158.10029,54.9204387,13.719616,-262774.277588675,553371.776907202,95.1880416870117,21,1.97858239212869,-0.508640128345584 +-158.04264,54.9224775,13.719616,-259070.467441436,553371.789227053,95.4257736206055,21,1.97966568947833,-0.504705283167818 +-157.98498,54.9244875,13.719616,-255366.4074931,553371.79089997,99.5639877319336,21,1.99810228262611,-0.43773831452752 +-157.92731,54.9264686,13.719616,-251662.092882909,553371.771617342,101.972625732422,21,2.00848360226261,-0.400030398484098 +-157.86964,54.9284208,13.719616,-247958.158114888,553371.769529704,102.994491577148,122,2.0128139980875,-0.384301164830076 +-157.81196,54.9303442,13.719616,-244253.956947041,553371.758123558,105.948120117188,122,2.02509325524242,-0.339699397994475 +-157.75428,54.9322388,13.719616,-240550.123909547,553371.774460462,105.556358337402,122,2.02348439877753,-0.345543223888331 +-157.69659,54.9341044,13.719616,-236846.014663726,553371.75982807,119.423034667969,122,2.07708810287664,-0.150839270579947 +-157.6389,54.9359413,13.719616,-233142.261850277,553371.783537538,116.138984680176,21,2.06497802498881,-0.194826530028911 +-157.5812,54.9377492,13.719616,-229438.221718161,553371.776901045,110.606658935547,21,2.0437812739118,-0.271819180095727 +-157.5235,54.9395283,13.719616,-225734.527553675,553371.797026826,116.374198913574,21,2.06585670444172,-0.191634915455879 +-157.46578,54.9412784,13.719616,-222029.894882626,553371.754045886,137.70930480957,21,2.13896328587003,0.0739090549875694 +-157.40807,54.9429998,13.719616,-218326.236562424,553371.782517945,159.962966918945,122,2.20401945062888,0.310211614269806 +-157.35035,54.9446922,13.719616,-214622.268668035,553371.782038835,192.487808227539,122,2.2844032274176,0.602188435380573 +-157.29262,54.9463557,13.719616,-210917.985056648,553371.764662577,232.823043823242,221,2.36702596270463,0.902297792819604 +-157.23489,54.9479903,13.719616,-207214.020217903,553371.762541212,372.476501464844,320,2.57109887948416,1.64354887477239 +-157.17716,54.9495961,13.719616,-203510.3680549,553371.786083066,661.339111328125,420,2.82042420746386,2.54916963052828 +-165.22138,54.4076846,12.82759378,-725773.899444959,549667.723952142,170.951309204102,10,2.23287243112232,0.415013874882508 +-165.16519,54.4132711,13.719616,-722070.078165768,549667.75485414,164.498748779297,10,2.21616259894062,0.354318994937647 +-165.10898,54.4188298,13.719616,-718366.009238855,549667.747590824,108.243545532227,10,2.03440200919806,-0.305887346644714 +-165.05276,54.4243606,13.719616,-714662.330206172,549667.799885025,90.2767639160156,10,1.95557598285359,-0.592205973515705 +-164.99652,54.4298635,13.719616,-710958.395514207,549667.804094458,68.3482360839844,11,1.83472731087345,-1.03116284379269 +-164.94026,54.4353386,13.719616,-707254.198392634,549667.772286676,57.8620071411133,11,1.76239349455896,-1.29389991077361 +-164.88399,54.4407858,10.41289352,-703550.376344915,549667.800537627,19.3067436218262,11,1.28570902953648,-3.02535394702739 +-164.3204,54.4937222,10.41562707,-666509.931630033,549667.735812864,17.6735057830811,11,1.24732270633915,-3.16478402942755 +-164.26396,54.498862,13.719616,-662806.072500476,549667.755444172,78.6249237060547,11,1.8955602370345,-0.810200292529976 +-164.20751,54.5039738,13.719616,-659102.53038539,549667.824832876,97.8866882324219,11,1.99072363541616,-0.464539667269627 +-164.15103,54.5090576,13.719616,-655398.019040722,549667.746168266,94.7641448974609,11,1.97664404811159,-0.515680747074149 +-164.09455,54.5141134,13.719616,-651694.45527285,549667.816764211,88.9644927978516,11,1.9492167071072,-0.615304678144607 +-164.03804,54.5191411,13.719616,-647989.913895328,549667.730819275,103.499740600586,11,2.01493926133037,-0.376581602121446 +-163.98153,54.5241408,13.719616,-644286.310014196,549667.793316597,79.9244537353516,11,1.90267967665429,-0.784340455740506 +-163.925,54.5291124,13.719616,-640582.35902846,549667.798276907,73.7089309692383,11,1.86752011249499,-0.912050028305822 +-163.86845,54.534056,13.719616,-636878.054224011,549667.757990024,79.9585952758789,11,1.90286515576507,-0.783666742669127 +-163.81189,54.5389714,13.719616,-633174.034444487,549667.747094423,89.9212417602539,11,1.95386229562159,-0.598430574677378 +-163.75532,54.5438588,13.719616,-629470.291331638,549667.787231697,92.5065612792969,11,1.96617253734806,-0.553716263034018 +-163.69873,54.5487181,13.719616,-625766.180844779,549667.772821195,87.9671173095703,11,1.94432036033432,-0.633089607180213 +-163.64213,54.5535493,13.719616,-622062.338514533,549667.798862882,88.0883483886719,11,1.94491846726388,-0.630917112095334 +-163.58551,54.5583523,13.719616,-618358.120246961,549667.760906025,100.475090026855,11,2.00205840399718,-0.423368552518318 +-163.52888,54.5631272,13.719616,-614654.159947395,549667.76386315,99.3056411743164,11,1.99697391980747,-0.441836850351629 +-163.47224,54.567874,13.719616,-610950.452526137,549667.807425286,102.944793701172,11,2.01260438763179,-0.385062529833997 +-163.41558,54.5725927,13.719616,-607246.352279572,549667.799856847,104.226951599121,11,2.01798003582802,-0.365536641222541 +-163.35891,54.5772832,13.719616,-603542.496285074,549667.822408898,94.4871673583984,11,1.97537282942066,-0.520298176201548 +-163.30222,54.5819455,13.719616,-599838.238804608,549667.784479034,85.6173324584961,11,1.93256169258726,-0.675800444695465 +-163.24552,54.5865796,13.719616,-596134.215318513,549667.777235469,74.670166015625,11,1.87314711690465,-0.891611142182951 +-163.18881,54.5911855,13.719616,-592430.420693282,549667.800419929,68.9441146850586,11,1.83849719917187,-1.0174695334596 +-163.13208,54.5957633,13.719616,-588726.20765653,549667.776156811,73.3932266235352,11,1.86565598122726,-0.918821085146242 +-163.07534,54.6003128,13.719616,-585022.214738804,549667.771934757,60.9735069274902,11,1.78514117444553,-1.21127384459132 +-163.01859,54.6048342,13.719616,-581318.433756733,549667.80957101,60.3422317504883,11,1.78062136846738,-1.22769106998502 +-162.96182,54.6093273,13.719616,-577614.221975658,549667.779830937,55.9010887145996,11,1.74742026617155,-1.34828695006153 +-162.90504,54.6137922,13.719616,-573910.213341934,549667.781624651,68.0076446533203,11,1.83255773394368,-1.03904336646054 +-162.84825,54.6182288,13.719616,-570206.404181754,549667.803733179,54.8061141967773,11,1.73882901129093,-1.37949283997623 +-162.79144,54.6226372,13.719616,-566502.147232808,549667.771698145,67.9863128662109,11,1.83242148851519,-1.03953824874511 +-162.73462,54.6270173,13.719616,-562798.079407246,549667.760738124,79.3602142333984,11,1.8996028315284,-0.795516435456784 +-162.67779,54.6313691,13.719616,-559094.195516108,549667.770690953,37.5794296264648,11,1.57495018417433,-1.97474751573788 +-162.62095,54.6356927,13.719616,-555390.488927239,549667.812438256,131.168487548828,11,2.1178295108973,-0.00285484789334842 +-162.56409,54.639988,13.719616,-551686.315294184,549667.791738929,148.232421875,110,2.1709432043276,0.190069246802931 +-162.50722,54.644255,13.719616,-547982.310029964,549667.79265145,54.3173217773438,13,1.73493834805455,-1.39362483935659 +-162.45034,54.6484936,13.719616,-544278.469345895,549667.804022204,42.9108238220215,13,1.63256685240085,-1.76546733130477 +-161.7668,54.6971468,13.719616,-499830.431428655,549667.797057077,90.9785537719727,13,1.9589390288465,-0.57999043056058 +-161.70976,54.7010168,13.719616,-496126.324088861,549667.79195703,86.3008117675781,13,1.93601488081975,-0.66325747939701 +-161.65271,54.7048583,13.719616,-492422.309221973,549667.789122764,78.5761489868164,13,1.89529074024623,-0.811179181786997 +-161.59565,54.7086714,13.719616,-488718.380259251,549667.799655668,88.1808547973633,13,1.94537430442429,-0.629261381419862 +-161.53857,54.712456,13.719616,-485013.892577381,549667.739529399,57.506591796875,13,1.75971762933183,-1.30361941704649 +-161.48149,54.7162122,13.719616,-481310.120842888,549667.766492796,78.516357421875,13,1.89496014334424,-0.812380004096778 +-161.4244,54.7199399,13.719616,-477606.420408262,549667.795982651,103.040924072266,110,2.01300974479142,-0.383590156929778 +-161.36729,54.7236392,13.719616,-473902.144121607,549667.767792254,163.407348632812,110,2.21327158340152,0.343818001321632 +-161.31017,54.72731,13.719616,-470197.928532806,549667.743443604,109.021415710449,13,2.0375118173105,-0.294591635952709 +-161.25305,54.7309523,13.719616,-466494.408938296,549667.793296322,70.301643371582,13,1.84696547720856,-0.986710330543144 +-161.19591,54.7345662,13.719616,-462790.297596331,549667.787496243,65.2351989746094,13,1.81448199136949,-1.10469962282057 +-161.13876,54.7381515,13.719616,-459086.232214616,549667.77485992,74.7289047241211,13,1.87348861699782,-0.890370716370734 +-161.0816,54.7417084,13.719616,-455382.205074061,549667.777664837,93.3966827392578,13,1.97033145124487,-0.538609900688603 +-161.02443,54.7452367,13.719616,-451678.213228612,549667.773945323,109.402778625488,13,2.03902835240319,-0.289083147633846 +-160.96725,54.7487365,13.719616,-447974.250157657,549667.774939624,96.1046905517578,110,1.98274458466161,-0.493521857058 +-160.91006,54.7522079,13.719616,-444270.309376233,549667.791901977,90.4790954589844,110,1.95654825019398,-0.588674421022706 +-160.85286,54.7556506,13.719616,-440566.389020161,549667.791826341,98.4886169433594,110,1.99338603877823,-0.454869058333028 +-160.79565,54.7590649,13.719616,-436862.480288091,549667.808126369,109.939949035645,110,2.04115553130587,-0.28135662670202 +-160.73842,54.7624506,13.719616,-433157.939515949,549667.753660527,112.106239318848,110,2.04962978410559,-0.250575721740866 +-160.68119,54.7658077,13.719616,-429454.042557954,549667.759664261,109.921829223633,110,2.04108394692726,-0.281616641597322 +-160.62395,54.7691363,13.719616,-425750.142325597,549667.771671042,103.42155456543,110,2.01461106151683,-0.377773717521804 +-160.5667,54.7724363,13.719616,-422046.234574127,549667.778863432,108.295547485352,110,2.03461060120248,-0.305129680946554 +-160.50944,54.7757077,13.719616,-418342.313929294,549667.781506925,107.961044311523,110,2.03326707685279,-0.310009744864675 +-160.45217,54.7789506,13.719616,-414638.373935044,549667.790955,97.0151290893555,110,1.98683946589179,-0.478648079634511 +-160.39489,54.7821649,13.719616,-410934.410311165,549667.796422655,90.3839950561523,13,1.9560915336371,-0.590333345917167 +-160.3376,54.7853506,13.719616,-407230.417676602,549667.798210878,93.4377136230469,13,1.97052220291641,-0.53791703617162 +-160.2803,54.7885077,13.719616,-403526.390648067,549667.796632562,82.08203125,13,1.91424809520623,-0.74232065760447 +-160.22299,54.7916362,13.719616,-399822.32384006,549667.792012463,79.3438415527344,13,1.89951322367488,-0.79584191675738 +-160.16567,54.794736,13.719616,-396118.212896626,549667.773606248,74.9390258789062,13,1.87470804346601,-0.885941411379318 +-160.10834,54.7978073,13.719616,-392414.050354874,549667.76392347,73.1092147827148,13,1.86397211946224,-0.924937351698794 +-160.05101,54.8008499,13.719616,-388710.473487446,549667.799692668,70.0452499389648,13,1.84537868929713,-0.992473997151798 +-159.99366,54.8038639,13.719616,-385006.194646949,549667.774747542,63.347900390625,13,1.80173222515669,-1.15101041285106 +-159.93631,54.8068493,13.719616,-381302.489658611,549667.805976612,63.3771705627441,13,1.80193284646021,-1.15028169901365 +-159.87894,54.809806,13.719616,-377598.07288648,549667.767301851,62.1733551025391,13,1.79360430412548,-1.18053334197603 +-159.7068,54.8185042,10.2667382,-366486.260196637,549667.782627393,12.8316764831543,13,1.10828340148934,-3.66981447041073 +-159.6494,54.8213463,13.719616,-362782.14316846,549667.775539881,48.4802589416504,13,1.68556493080818,-1.57296318337174 +-159.53458,54.8269444,13.38948261,-355374.249380606,549667.782657042,33.5928230285645,13,1.52624650203192,-2.15165319069399 +-159.47716,54.8297004,13.719616,-351670.461740377,549667.796689489,44.8423309326172,13,1.6516881794105,-1.69601321383561 +-159.41972,54.8324277,13.719616,-347965.918864645,549667.747748699,47.5038375854492,13,1.67672869541146,-1.60505891244532 +-159.36228,54.8351264,13.719616,-344261.895632101,549667.752779178,47.216552734375,13,1.67409427619697,-1.61462787497043 +-159.30484,54.8377963,13.719616,-340558.388400628,549667.788435729,16.4204139709473,13,1.21538410181094,-3.28079415725934 +-159.24738,54.8404375,13.719616,-336854.109592508,549667.763218382,40.9321556091309,13,1.61206461648743,-1.83993730406306 +-159.18992,54.8430501,13.719616,-333150.334109549,549667.790763936,47.5338554382324,13,1.6770030410493,-1.60406241078263 +-159.13245,54.8456338,13.719616,-329446.418494984,549667.787054905,59.9257202148438,13,1.77761326228772,-1.23861737022854 +-159.07497,54.8481889,13.719616,-325742.354687656,549667.785940852,68.1874465942383,13,1.83370442778449,-1.03487824713169 +-159.01748,54.8507152,13.719616,-322038.138940223,549667.76580231,73.7819519042969,13,1.86795014031952,-0.91048804450495 +-158.95999,54.8532128,13.719616,-318334.40554604,549667.786256319,75.5819778442383,13,1.87841825243413,-0.87246487340803 +-158.90249,54.8556817,13.719616,-314630.508434476,549667.798852167,77.5077514648438,13,1.88934513799104,-0.832775306221674 +-158.84498,54.8581218,13.719616,-310926.442955155,549667.79310033,78.4064025878906,13,1.89435152818261,-0.814590668079867 +-158.78746,54.8605332,13.719616,-307222.202814231,549667.780722703,84.6788940429688,13,1.92777517723858,-0.69318643464935 +-158.72994,54.8629158,13.719616,-303518.423949408,549667.79695562,93.9522323608398,13,1.97290710365396,-0.529254395974394 +-158.67241,54.8652696,13.719616,-299814.460254318,549667.79562582,102.8193359375,120,2.01207479463303,-0.386986162766388 +-158.61487,54.8675946,13.719616,-296110.306231652,549667.777390739,126.552474975586,120,2.10227064303619,-0.0593690969079172 +-158.55732,54.8698909,13.719616,-292405.955619259,549667.754024033,149.811782836914,120,2.1755459723742,0.206787814108984 +-158.49977,54.8721585,13.719616,-288702.043556148,549667.769681708,167.306243896484,120,2.22351214920619,0.381014659272703 +-158.44221,54.8743972,13.719616,-284997.925446086,549667.758261774,170.28955078125,120,2.2311879998283,0.408895539638094 +-158.38465,54.8766071,13.719616,-281294.235632816,549667.773931124,182.848556518555,120,2.26209153618896,0.521146004447458 +-158.32708,54.8787883,13.719616,-277590.327275479,549667.785043155,190.10627746582,120,2.27899645786362,0.582549505114855 +-158.2695,54.8809406,13.719616,-273886.196326113,549667.770116067,184.407577514648,120,2.26577876273271,0.534539063693593 +-158.21192,54.8830642,13.719616,-270182.476447202,549667.792790463,172.105438232422,120,2.23579459349442,0.425628002686184 +-158.15433,54.885159,13.719616,-266478.522242651,549667.800916338,163.87580871582,120,2.21451484791676,0.348333892904022 +-158.09673,54.8872249,13.719616,-262774.328887107,549667.784152181,93.6351928710938,21,1.97143910939081,-0.534586570145453 +-158.03912,54.889262,13.719616,-259069.890162104,549667.754386168,100.595840454102,21,2.00258002341197,-0.421473881918787 +-157.98152,54.8912703,13.719616,-255366.481774672,549667.789315452,109.875190734863,122,2.04089964198423,-0.282286089756278 +-157.9239,54.8932498,13.719616,-251662.176376629,549667.77271447,114.500091552734,122,2.05880583393208,-0.217245689665693 +-157.86628,54.8952005,13.719616,-247958.249672138,549667.781747321,123.289085388184,122,2.09092463080905,-0.100581051791175 +-157.80865,54.8971223,13.719616,-244254.056169694,549667.767678699,125.676620483398,122,2.09925449376055,-0.0703246119717347 +-157.75102,54.8990153,13.719616,-240550.230302656,549667.778682937,129.838195800781,122,2.11340247201219,-0.0189351167267485 +-157.69338,54.9008794,13.719616,-236846.126557485,549667.767163786,128.770751953125,122,2.10981723175202,-0.0319577326811554 +-157.63574,54.9027147,13.719616,-233142.379384121,549667.780206005,126.191055297852,122,2.10102857224205,-0.0638806525545334 +-157.57809,54.9045212,13.719616,-229438.342647663,549667.782467026,143.754150390625,21,2.15762039225367,0.141676990641279 +-157.52043,54.9062988,13.719616,-225734.011412428,549667.763722913,174.919967651367,21,2.24283938835705,0.451216708411889 +-157.46277,54.9080476,13.719616,-222030.020153382,549667.769424047,195.007827758789,122,2.29005204461491,0.622706551774159 +-157.40511,54.9097675,13.719616,-218326.363913006,549667.787696969,231.260437011719,221,2.36410134199188,0.891674735621021 +-157.34744,54.9114585,13.719616,-214622.396522367,549667.785478029,285.933563232422,221,2.45626513636921,1.22643994296541 +-157.28976,54.9131207,13.719616,-210918.111870904,549667.774823699,394.679931640625,320,2.59624504430959,1.73488692284836 +-157.23208,54.914754,13.719616,-207214.145579232,549667.776771196,559.556579589844,420,2.74784400679164,2.285537625235 +-165.32405,54.3636071,10.35348393,-733182.030144551,545963.740984412,128.207580566406,10,2.10791370459644,-0.0388718866309564 +-165.26794,54.3692448,13.719616,-729478.30068801,545963.791442957,163.378784179688,10,2.21319565983465,0.343542225256038 +-165.21181,54.3748547,13.719616,-725774.330964803,545963.799592011,166.073135375977,10,2.22029938500056,0.369344982663653 +-165.15566,54.3804367,13.719616,-722070.117931931,545963.755529607,163.231307983398,10,2.21280346067027,0.342117645946202 +-165.0995,54.385991,13.719616,-718366.29412374,545963.790427496,147.547653198242,10,2.16893230627136,0.182765091095242 +-165.04332,54.3915174,13.719616,-714662.217171742,545963.774152482,93.4803314208984,10,1.97072024345074,-0.537197696424525 +-164.98713,54.397016,13.719616,-710958.521471848,545963.825818097,85.0564422607422,11,1.92970721309654,-0.686168728955325 +-164.93091,54.4024868,13.719616,-707253.919770374,545963.731862802,64.8725509643555,11,1.81206097590095,-1.11349344202893 +-164.87469,54.4079297,13.51807657,-703550.33246569,545963.801917593,46.4158630371094,11,1.66666642995403,-1.64160793264317 +-164.31157,54.4608239,13.7039396,-666510.177834917,545963.772305013,56.9367332458496,11,1.75539254581058,-1.31932935489744 +-164.25518,54.4659596,13.719616,-662806.5265683,545963.823545732,102.00464630127,11,2.00861995428197,-0.399535129031059 +-164.19876,54.4710674,13.719616,-659101.906490316,545963.733996437,108.533981323242,11,2.03556573441152,-0.301660364509161 +-164.14234,54.4761471,13.719616,-655398.239498159,545963.780654183,108.272789001465,11,2.03451932392562,-0.305461226069256 +-164.0859,54.4811988,13.719616,-651694.236520088,545963.776155991,108.39826965332,11,2.03502234967458,-0.30363409297119 +-164.02944,54.4862226,13.719616,-647989.890855328,545963.732762919,103.124542236328,11,2.01336203375504,-0.382310542860612 +-163.97298,54.4912182,13.719616,-644286.484830837,545963.812788756,81.4426040649414,11,1.91085165144841,-0.754657510774445 +-163.91649,54.4961859,13.719616,-640582.084886777,545963.757791974,86.9625930786133,11,1.93933248120407,-0.651207007863716 +-163.85999,54.5011255,13.719616,-636877.971642011,545963.740542623,90.0536346435547,11,1.9545012460149,-0.596109724474276 +-163.80348,54.506037,13.719616,-633174.140028138,545963.760670162,99.8494644165039,11,1.99934573969665,-0.433221723529327 +-163.74695,54.5109205,13.719616,-629469.942178229,545963.734035338,97.996337890625,11,1.99120984647198,-0.462773609936445 +-163.69041,54.5157759,13.719616,-625766.015831381,545963.745187254,104.162094116211,11,2.01770970254106,-0.366518568881587 +-163.63386,54.5206032,13.719616,-622062.355909486,545963.793787928,99.8409271240234,11,1.99930860522074,-0.433356606545062 +-163.57729,54.5254024,13.719616,-618358.316162756,545963.786399491,100.978164672852,11,2.00422747291823,-0.415489875083174 +-163.5207,54.5301736,13.719616,-614653.889917369,545963.73538917,106.297950744629,11,2.02652489209735,-0.334499284307546 +-163.46411,54.5349165,13.719616,-610950.359190645,545963.793084751,106.672325134277,11,2.028051761501,-0.328953258821579 +-163.4075,54.5396314,13.719616,-607246.431786804,545963.80767425,107.615341186523,11,2.0318741869227,-0.315069118661107 +-163.35087,54.5443181,13.719616,-603542.105762446,545963.758522741,99.9344482421875,11,1.99971521898335,-0.431879669300148 +-163.29423,54.5489767,13.719616,-599838.015609044,545963.748364668,92.6957702636719,11,1.96705991760667,-0.550493044651224 +-163.23758,54.5536071,13.719616,-596134.157768873,545963.765921261,68.7106399536133,11,1.83702399346928,-1.02282063706615 +-163.18092,54.5582094,13.719616,-592430.525577476,545963.821956538,84.9865036010742,11,1.92934996245583,-0.687466365251851 +-163.12424,54.5627835,13.719616,-588726.474283709,545963.816562093,82.2420272827148,11,1.91509380723054,-0.739248790141932 +-163.06754,54.5673294,13.719616,-585021.998750026,545963.751178574,73.6827697753906,11,1.86736594286142,-0.912610016419334 +-163.01084,54.5718471,13.719616,-581318.376172814,545963.802324365,70.7993698120117,11,1.85002939203463,-0.975581317366493 +-162.95412,54.5763366,13.719616,-577614.319071467,545963.794164605,74.2930221557617,11,1.8709480253143,-0.899598870522347 +-162.89739,54.5807979,13.719616,-573910.463467842,545963.814591052,74.7609634399414,11,1.87367488946916,-0.889694121587395 +-162.84064,54.5852309,13.719616,-570206.164520451,545963.766528475,79.0370407104492,11,1.89783067111421,-0.801953427906044 +-162.78388,54.5896358,13.719616,-566502.055282506,545963.758827807,88.4746170043945,11,1.94681869130686,-0.624014955993292 +-162.72711,54.5940124,13.719616,-562798.133542279,545963.769268046,70.517219543457,11,1.84829517996393,-0.981880470600676 +-162.67033,54.5983607,13.719616,-559094.394113004,545963.797690481,88.9645309448242,110,1.94921689332774,-0.615304001738441 +-162.61353,54.6026808,13.719616,-555390.189197529,545963.771350516,149.883193969727,110,2.17575293921658,0.207539576754737 +-162.55672,54.6069726,13.719616,-551686.156229518,545963.763827,155.174087524414,13,2.19081920026799,0.262264537232492 +-162.4999,54.6112362,13.719616,-547982.288593347,545963.786029589,119.339767456055,13,2.07678518724823,-0.151939546603079 +-162.44306,54.6154715,13.719616,-544277.941361065,545963.744856347,59.2183570861816,13,1.77245635444972,-1.25734873142419 +-161.87405,54.6562667,13.719616,-507238.379939228,545963.797511788,50.3389701843262,13,1.70190432667044,-1.5136138338721 +-161.81708,54.6601903,13.719616,-503534.188866853,545963.776200271,77.1574935913086,13,1.88737811144018,-0.8399201080997 +-161.7601,54.6640855,13.719616,-499830.097988657,545963.765271896,131.032379150391,13,2.11737862656243,-0.00449258849278542 +-161.70311,54.6679523,13.719616,-496126.102041885,545963.764756881,74.5060043334961,13,1.8721912733366,-0.895083038847052 +-161.64611,54.6717907,13.719616,-492422.195761124,545963.774696971,50.8614692687988,13,1.70638890177196,-1.49732457707823 +-161.5891,54.6756007,13.719616,-488718.373878332,545963.795145396,57.4859886169434,13,1.75956200455296,-1.30418469066311 +-161.53207,54.6793823,13.719616,-485013.989954365,545963.75313473,82.7566146850586,13,1.91780271672461,-0.7294092576597 +-161.47504,54.6831354,13.719616,-481310.322302738,545963.78430669,93.3454437255859,110,1.97009312450119,-0.539475571446881 +-161.41799,54.6868602,13.719616,-477606.080801592,545963.765354519,112.398422241211,110,2.05076021499866,-0.246469674080152 +-161.36093,54.6905565,13.719616,-473901.903831103,545963.747295433,132.374282836914,110,2.1218036202482,0.0115802515928695 +-161.30387,54.6942243,13.719616,-470198.427250357,545963.801038134,110.586036682129,110,2.04370029356238,-0.272113323838902 +-161.24679,54.6978637,13.719616,-466494.362198624,545963.79560273,84.8104934692383,110,1.92844959015581,-0.690736774437363 +-161.1897,54.7014746,13.719616,-462790.34576074,545963.791420053,71.3274230957031,110,1.85325653419127,-0.963859415935506 +-161.1326,54.705057,13.719616,-459086.372619754,545963.788632511,69.8416748046875,110,1.8441146452123,-0.997065366062 +-161.07549,54.708611,13.719616,-455382.436272951,545963.798458474,86.7941436767578,110,1.93849042270332,-0.654265604685892 +-161.01836,54.7121365,13.719616,-451677.891432252,545963.741988952,83.639518737793,110,1.92241152522021,-0.712668749718771 +-160.96123,54.7156335,13.719616,-447974.015110316,545963.755984043,75.9162521362305,110,1.88033475952552,-0.865503572626529 +-160.90409,54.719102,13.719616,-444270.160811906,545963.77206255,90.2698593139648,110,1.95554276561011,-0.592326628025177 +-160.84694,54.722542,13.719616,-440566.323207866,545963.790425208,105.815620422363,110,2.02454978265662,-0.341673445548639 +-160.78978,54.7259534,13.719616,-436862.49810237,545963.800214837,114.348083496094,110,2.05822889011421,-0.219341314288361 +-160.7326,54.7293364,13.719616,-433158.036712089,545963.758569968,110.578598022461,110,2.04367107940839,-0.272219437984745 +-160.67542,54.7326908,13.719616,-429454.21829964,545963.774591617,110.092948913574,110,2.04175950474843,-0.279162822767439 +-160.61823,54.7360167,13.719616,-425750.39522224,545963.793815507,110.269393920898,110,2.04245498754673,-0.276636630733479 +-160.56102,54.7393141,13.719616,-422045.92097051,545963.752950429,109.869468688965,110,2.04087702434278,-0.282368243485768 +-160.50381,54.7425828,13.719616,-418342.074714361,545963.757777078,110.470336914062,110,2.04324567852822,-0.273764615403027 +-160.44659,54.7458231,13.719616,-414638.206647079,545963.777691158,100.504821777344,110,2.00218689778696,-0.422901826398062 +-160.38936,54.7490348,13.719616,-410934.31358752,545963.790837061,94.1917037963867,110,1.97401265274917,-0.525238726105475 +-160.33212,54.7522179,13.719616,-407230.390157115,545963.797518399,88.6479187011719,13,1.94766854357814,-0.620928049972013 +-160.27487,54.7553724,13.719616,-403526.430975071,545963.79805062,81.7988052368164,13,1.91274696036023,-0.74777320783167 +-160.21761,54.7584983,13.719616,-399822.430658388,545963.792761039,81.5628509521484,13,1.9114923977234,-0.752330137416474 +-160.16034,54.7615957,13.719616,-396118.38279108,545963.793069358,74.8059234619141,13,1.87393598857259,-0.888745735118601 +-160.10306,54.7646645,13.719616,-392414.283035685,545963.788248043,75.6578063964844,13,1.87885374531368,-0.870883038967464 +-160.04577,54.7677046,13.719616,-388710.127014387,545963.767577659,76.1041641235352,13,1.88140842032375,-0.861603730154052 +-159.98847,54.7707162,13.719616,-385005.907302621,545963.753596882,73.9247589111328,13,1.86878991684732,-0.907437736459899 +-159.93117,54.7736991,13.719616,-381302.261688951,545963.781942274,72.5537796020508,13,1.86066004141274,-0.936967764535754 +-159.87385,54.7766534,13.719616,-377597.901428857,545963.748706268,69.4123611450195,13,1.84143681770321,-1.00679199990309 +-159.81653,54.7795791,13.64926602,-373894.103461417,545963.768572649,63.3458976745605,13,1.80171849491023,-1.15106028502517 +-159.7592,54.7824761,13.29965097,-370190.222182046,545963.773461685,46.3664207458496,13,1.66620357184312,-1.64328916541489 +-159.70186,54.7853445,13.719616,-366486.251205731,545963.774893008,46.2406196594238,13,1.66502364532738,-1.6475749953046 +-159.64451,54.7881843,13.719616,-362782.185128451,545963.773313132,45.9118118286133,13,1.66192443176934,-1.658832223551 +-159.47241,54.7965317,13.719616,-351670.007053394,545963.763739818,37.8539085388184,13,1.578110728465,-1.96326751676502 +-159.41503,54.7992568,13.719616,-347966.15034196,545963.773378428,50.7399978637695,13,1.70535044460126,-1.5010965499274 +-159.35764,54.8019532,13.719616,-344262.172319302,545963.770204858,56.9171295166016,13,1.75524298932976,-1.31987258672345 +-159.30024,54.804621,13.719616,-340558.066653696,545963.765828826,59.6181030273438,13,1.77537815321517,-1.24673592434368 +-159.24284,54.8072601,13.719616,-336854.469973725,545963.800409071,54.7850952148438,13,1.73866242077642,-1.38009794427461 +-159.18542,54.8098705,13.719616,-333150.094494196,545963.772482814,56.1979331970215,13,1.74972034372504,-1.33993241187978 +-159.128,54.8124521,13.719616,-329446.217960531,545963.772393819,61.3647117614746,13,1.78791869861769,-1.2011850840137 +-159.07057,54.8150051,13.719616,-325742.192025764,545963.772175161,67.8403854370117,13,1.83148830671168,-1.04292783141205 +-159.01313,54.8175294,13.719616,-322038.012104281,545963.761308094,74.4207077026367,13,1.87169379562221,-0.896890019899994 +-158.95569,54.820025,13.719616,-318334.313909093,545963.788315156,78.0767669677734,13,1.89252182160118,-0.821236684633874 +-158.89824,54.8224918,13.719616,-314630.451634566,545963.793648566,72.5475082397461,13,1.86062250049102,-0.93710412387871 +-158.84078,54.8249299,13.719616,-310926.418982379,545963.789018829,77.1946640014648,13,1.88758728123196,-0.839160343712917 +-158.78331,54.8273393,13.719616,-307222.21049179,545963.775050964,86.1995315551758,13,1.93550490569066,-0.665109854627239 +-158.72584,54.82972,13.719616,-303518.46186884,545963.798085147,95.8220138549805,13,1.98146529402071,-0.49816860581162 +-158.66836,54.8320719,13.719616,-299814.527262603,545963.8008502,105.373756408691,120,2.02273246224224,-0.348274472008545 +-158.61087,54.834395,13.719616,-296110.401178446,545963.784005488,126.029449462891,120,2.10047203912403,-0.0659021396895438 +-158.55337,54.8366895,13.719616,-292406.076595096,545963.770429547,152.324615478516,120,2.18277009048422,0.233027873053163 +-158.49587,54.8389551,13.719616,-288702.19149941,545963.770969879,169.4677734375,120,2.22908712348939,0.401264557125351 +-158.43836,54.841192,13.719616,-284998.097707986,545963.763942641,182.618621826172,120,2.26154506095292,0.51916105041059 +-158.38085,54.8434002,13.719616,-281294.430917012,545963.792414669,191.383590698242,120,2.28190469846324,0.59311306506718 +-158.32332,54.8455796,13.719616,-277589.904039655,545963.760731472,196.699752807617,120,2.29380381414224,0.636334049559049 +-158.2658,54.8477302,13.719616,-273886.435077116,545963.795022158,192.811248779297,120,2.28513236743127,0.604836880027519 +-158.20826,54.849852,13.719616,-270182.095018095,545963.770635351,178.924530029297,120,2.25266988515131,0.486923878671764 +-158.15072,54.851945,13.719616,-266478.160692239,545963.770252701,164.459594726562,120,2.21605921570403,0.353943477513849 +-158.09317,54.8540093,13.719616,-262773.984736668,545963.764511473,97.432991027832,21,1.98870603485962,-0.471868168371521 +-158.03562,54.8560447,13.719616,-259070.204190278,545963.770986689,103.103118896484,21,2.01327180300462,-0.38263828670059 +-157.97806,54.8580514,13.719616,-255366.171011334,545963.772565058,113.306442260742,122,2.05425460323278,-0.233777058616097 +-157.9205,54.8600293,13.719616,-251662.521540662,545963.796838849,119.621925354004,122,2.07781078824404,-0.148214271050623 +-157.86292,54.8619783,13.719616,-247957.968573684,545963.757168543,131.222671508789,122,2.11800887513531,-0.0022033457852258 +-157.80535,54.8638986,13.719616,-244254.42879615,545963.78861771,134.403305053711,122,2.12840994839742,0.0355763210646431 +-157.74776,54.86579,13.719616,-240549.974469612,545963.757796007,152.151901245117,122,2.18227738354338,0.231238220811467 +-157.69018,54.8676527,13.719616,-236846.52231561,545963.796447561,171.923355102539,122,2.23533487786904,0.423958184318875 +-157.63258,54.8694865,13.719616,-233142.144554471,545963.774550792,191.285430908203,122,2.28168189361787,0.592303774273956 +-157.57498,54.8712915,13.719616,-229438.11737399,545963.774868099,217.587432861328,221,2.33763380832123,0.795537098742992 +-157.51738,54.8730676,13.719616,-225734.435840669,545963.785504343,268.663543701172,221,2.42920873884263,1.12816338448416 +-157.45977,54.8748149,13.719616,-222030.452653523,545963.783372213,290.712280273438,320,2.46346337763333,1.25258600981928 +-157.40215,54.8765334,13.719616,-218326.1622873,545963.769389143,389.237609863281,320,2.59021479708178,1.71298334371303 +-157.34453,54.8782231,13.719616,-214622.200384001,545963.776802208,504.262237548828,320,2.70265644656837,2.12140350869032 +-165.37045,54.3251226,13.31378066,-736886.067442032,542259.750564032,77.5202713012695,10,1.8894152839658,-0.832520516019698 +-165.3144,54.3307836,13.719616,-733182.193118152,542259.776244353,108.812347412109,10,2.03667817944934,-0.297619646608375 +-165.25833,54.3364168,13.719616,-729478.080976395,542259.756536003,185.435256958008,10,2.26819231042653,0.543305757812643 +-165.20225,54.3420222,13.719616,-725774.367845915,542259.801781183,161.339797973633,10,2.20774150879269,0.323731191901942 +-165.14615,54.3475999,13.719616,-722070.405242046,542259.813611446,152.943572998047,10,2.18453123176118,0.239424840850845 +-165.09003,54.3531497,13.719616,-718366.191985309,542259.771176513,129.91569519043,10,2.11366162161065,-0.0179938114164964 +-165.0339,54.3586718,13.719616,-714662.361187839,542259.805107606,131.844619750977,10,2.12006241201996,0.00525568631758596 +-164.97775,54.364166,13.719616,-710958.269899825,542259.785841054,77.7273788452148,11,1.89057402249446,-0.828311646946708 +-164.92158,54.3696324,13.719616,-707253.911357844,542259.725452088,57.2670707702637,11,1.7579049693741,-1.31020351539763 +-164.8654,54.375071,13.719616,-703549.922369718,542259.730998494,58.0306549072266,11,1.76365747183956,-1.28930878451543 +-164.80921,54.3804817,13.719616,-699846.299815738,542259.790961892,39.6069297790527,11,1.59777117838778,-1.8918551509944 +-164.753,54.3858646,11.09522149,-696142.395223515,542259.81095721,34.4707336425781,11,1.53745052662039,-2.11095697544169 +-164.69677,54.3912196,9.325024111,-692438.205447834,542259.781156881,22.5577278137207,11,1.35329535206396,-2.77986113255056 +-164.47171,54.4123606,8.635008084,-677622.345612678,542259.79948435,13.2979154586792,11,1.12378356760275,-3.61351344289892 +-164.4154,54.4175761,12.68945524,-673917.93890067,542259.737863489,39.2398910522461,11,1.59372779291092,-1.90654188114347 +-164.35909,54.4227636,13.719616,-670214.502372999,542259.82216073,67.5887985229492,11,1.82987472637409,-1.04878881575988 +-164.30275,54.4279232,13.719616,-666510.104123798,542259.760149176,76.0654525756836,11,1.88118745358485,-0.862406344419909 +-164.2464,54.4330548,13.719616,-662806.024330767,542259.743348676,93.3817749023438,11,1.97026212428496,-0.538861715994886 +-164.19004,54.4381585,13.719616,-659102.256278632,542259.782313902,113.319595336914,11,2.05430501499013,-0.233593948724465 +-164.13366,54.4432342,13.719616,-655398.154941087,542259.766941155,108.922210693359,11,2.03711644723076,-0.296027732932173 +-164.07727,54.4482819,13.719616,-651694.357022392,542259.79661803,99.4000244140625,11,1.99738649106624,-0.440338273780205 +-164.02086,54.4533016,13.719616,-647990.215771014,542259.773366626,107.324951171875,11,2.03070069956666,-0.31933155968488 +-163.96444,54.4582933,13.719616,-644286.367884595,542259.795480512,81.305290222168,11,1.91011880438311,-0.757319420490993 +-163.908,54.463257,13.719616,-640582.166605032,542259.766118699,79.6013107299805,11,1.90092021897022,-0.790731308248262 +-163.85155,54.4681927,13.719616,-636878.24862343,542259.782480761,91.9992065429688,11,1.96378408174233,-0.562391815527122 +-163.79508,54.4731003,13.719616,-633173.968809835,542259.737860177,98.362190246582,11,1.99282819067886,-0.45689532185563 +-163.7386,54.4779799,13.719616,-629469.962195528,542259.739362184,103.005752563477,11,2.0128614794315,-0.384128699036148 +-163.68211,54.4828314,13.719616,-625766.225351654,542259.775640573,102.750061035156,11,2.01178208852595,-0.388049354893936 +-163.6256,54.4876549,13.719616,-622062.109869295,542259.763699585,107.900001525879,11,2.03302145082453,-0.310901928707949 +-163.56908,54.4924503,13.719616,-618358.254020733,542259.786995708,101.12092590332,11,2.00484103752911,-0.413261233287662 +-163.51254,54.4972176,13.719616,-614654.010997297,542259.752663437,107.494491577148,11,2.03138620993588,-0.31684159035973 +-163.45599,54.5019568,13.719616,-610950.017439617,542259.754069592,106.363739013672,11,2.02679359571917,-0.333523276057427 +-163.39943,54.5066678,13.719616,-607246.269828104,542259.779910781,106.769256591797,11,2.02844621884785,-0.327520477148483 +-163.34285,54.5113508,13.719616,-603542.118196957,542259.761051388,92.9919738769531,11,1.96844546628113,-0.54546033639062 +-163.28626,54.5160057,13.719616,-599838.200755953,542259.778206554,85.6515121459961,11,1.93273503467882,-0.675170816742157 +-163.22966,54.5206324,13.719616,-596134.513948045,542259.820101517,54.1315231323242,11,1.73345024727686,-1.39903004612743 +-163.17304,54.525231,13.719616,-592430.409386052,542259.808296864,58.2459716796875,11,1.76526589471473,-1.28346653354322 +-163.11641,54.5298014,13.719616,-588726.525214251,542259.821859102,60.387321472168,11,1.78094576655722,-1.22651276353028 +-163.05976,54.5343436,13.719616,-585022.214570981,542259.772468068,59.9974327087402,11,1.77813266731228,-1.23673074292637 +-163.0031,54.5388577,13.719616,-581318.11254051,542259.760134784,57.8608283996582,11,1.76238464719694,-1.29393204691772 +-162.94643,54.5433436,13.719616,-577614.215503626,542259.773632645,55.5696678161621,11,1.74483780067167,-1.35766720186615 +-162.88975,54.5478013,13.719616,-573910.518315825,542259.81276584,63.9964256286621,11,1.80615571815422,-1.13494302369339 +-162.83305,54.5522309,13.719616,-570206.372628108,542259.802515899,63.885684967041,11,1.805403555556,-1.13767509293872 +-162.77634,54.5566322,13.719616,-566502.417976231,542259.807633285,89.6905517578125,11,1.95274669571337,-0.602482751967928 +-162.71961,54.5610053,13.719616,-562798.005995858,542259.754235934,108.85277557373,11,2.03683950734116,-0.297033657657706 +-162.66288,54.5653501,13.719616,-559094.416430164,542259.801189141,142.551452636719,110,2.15397164724279,0.128423707306243 +-162.60613,54.5696667,13.719616,-555390.35920153,542259.790448916,158.999664306641,110,2.20139620740267,0.300683246124044 +-162.54937,54.5739551,13.719616,-551686.470874003,542259.806630947,117.130584716797,13,2.06867031129277,-0.181415092289505 +-162.49259,54.5782153,13.719616,-547982.104556296,542259.767103673,145.653137207031,13,2.16331984328589,0.162379023575579 +-162.4358,54.5824471,13.719616,-544277.899625465,542259.733318468,113.851631164551,13,2.05633925717943,-0.22620500046239 +-162.37901,54.5866507,13.719616,-540574.489780502,542259.808644216,76.8887481689453,13,1.88586279018281,-0.845424187422193 +-162.32219,54.590826,13.719616,-536869.946059608,542259.737763964,107.174812316895,13,2.03009273165262,-0.321539872680013 +-162.26537,54.5949731,13.719616,-533166.187055659,542259.77583508,107.948677062988,13,2.03321732431949,-0.310190460266401 +-162.20853,54.5990918,13.719616,-529461.926880238,542259.739591409,83.6873474121094,13,1.92265980250378,-0.71176693575945 +-161.92417,54.6192608,13.719616,-510941.889281856,542259.743397338,129.683074951172,13,2.11288329963884,-0.0208208989733251 +-161.86727,54.6232095,13.719616,-507238.357208095,542259.790259137,66.3944702148438,13,1.82213190986221,-1.07691293535089 +-161.81035,54.62713,13.719616,-503534.284698992,542259.789767867,122.648811340332,13,2.08866334356698,-0.108794692490031 +-161.75342,54.631022,13.719616,-499830.312167799,542259.785737817,151.579360961914,13,2.18064007180689,0.225291037249256 +-161.69648,54.6348857,13.719616,-496126.431752588,542259.80030182,79.266487121582,13,1.89908961185156,-0.797380595810539 +-161.63952,54.638721,13.719616,-492421.99776951,542259.748307883,55.5359535217285,13,1.74457423286462,-1.35862455537108 +-161.58256,54.642528,13.719616,-488718.287137717,542259.789719101,63.1724281311035,13,1.80052757000301,-1.15538606421201 +-161.52558,54.6463065,13.719616,-485014.013681091,542259.754759218,80.5621032714844,13,1.90613079601721,-0.771805005166854 +-161.4686,54.6500566,13.719616,-481310.454304112,542259.801182213,95.5421447753906,13,1.98019498630532,-0.502782726015847 +-161.4116,54.6537783,13.719616,-477606.320280824,542259.783572309,118.416007995605,13,2.07341041618946,-0.164197678344078 +-161.35459,54.6574716,13.719616,-473902.248061423,542259.775063976,142.237945556641,13,2.15301547084873,0.124950601723118 +-161.29757,54.6611365,13.719616,-470198.232367333,542259.775771067,122.991226196289,13,2.08987413135448,-0.104396765652587 +-161.24054,54.664773,13.719616,-466494.267917463,542259.785819,97.6917343139648,13,1.98985781966868,-0.467684557192887 +-161.1835,54.668381,13.719616,-462790.350629428,542259.794283027,77.4834136962891,110,1.88920874623399,-0.833270720013374 +-161.12645,54.6719605,13.719616,-459086.47518867,542259.801308437,90.5401916503906,110,1.95684140945036,-0.587609582927518 +-161.06938,54.6755116,13.719616,-455381.993369725,542259.749545754,82.870475769043,110,1.91839983218601,-0.727240363870205 +-161.01231,54.6790343,13.719616,-451678.183334073,542259.776864975,82.6242141723633,110,1.91710734199773,-0.731935057147453 +-160.95523,54.6825284,13.719616,-447974.400388474,542259.792189502,87.2329559326172,110,1.94068058901227,-0.646310295516055 +-160.89813,54.6859941,13.719616,-444269.995146464,542259.750945084,86.0987701416016,110,1.93499694791671,-0.666954902247812 +-160.84103,54.6894313,13.719616,-440566.246906478,542259.776622096,88.4204940795898,110,1.94655293734479,-0.624980250237259 +-160.78392,54.69284,13.719616,-436862.508613174,542259.801980971,99.9589385986328,110,1.99982163597778,-0.431493132401935 +-160.72679,54.6962203,13.719616,-433158.132083698,542259.773094974,101.59009552002,110,2.00685136866956,-0.405959136779915 +-160.66966,54.699572,13.719616,-429454.397696511,542259.799068758,100.958030700684,110,2.00414087058303,-0.415804439483386 +-160.61251,54.7028952,13.719616,-425750.015528352,542259.76133192,105.583312988281,110,2.02359528515078,-0.345140452930541 +-160.55536,54.7061898,13.719616,-422046.264789821,542259.777847733,96.0867919921875,110,1.98266369402509,-0.493815674938309 +-160.4982,54.709456,13.719616,-418342.496211249,542259.806369381,103.299674987793,110,2.01409895509919,-0.379633834200368 +-160.44102,54.7126936,13.719616,-414638.064907059,542259.762599895,96.7812194824219,110,1.98579109009282,-0.482456079772626 +-160.38384,54.7159027,13.719616,-410934.247887866,542259.783337835,94.7497100830078,110,1.9765778897795,-0.515921053019756 +-160.32665,54.7190832,13.719616,-407230.39913843,542259.794822339,86.8130874633789,110,1.93858520195847,-0.653921339378473 +-160.26945,54.7222352,13.719616,-403526.512231514,542259.80844956,78.5298080444336,13,1.8950345358791,-0.812109789176419 +-160.21223,54.7253586,13.719616,-399821.941128395,542259.753268989,82.0178833007812,13,1.91390855692108,-0.74355395757002 +-160.15501,54.7284534,13.719616,-396117.96389885,542259.750588428,79.286506652832,13,1.89919928334739,-0.796982237634296 +-160.09778,54.7315197,13.719616,-392413.932411492,542259.7510805,77.3302459716797,13,1.88834939158207,-0.836392141393369 +-160.04055,54.7345574,13.719616,-388710.484044958,542259.802562508,79.8652725219727,13,1.9023579779296,-0.785508957330548 +-159.9833,54.7375665,13.719616,-385006.329957669,542259.787792142,76.2044677734375,13,1.8819804342329,-0.859526012366973 +-159.92604,54.740547,13.719616,-381302.106484629,542259.766247298,71.6604080200195,13,1.85527927662298,-0.956512238075348 +-159.86878,54.7434989,13.719616,-377598.44995876,542259.795186841,71.4933013916016,13,1.85426535222139,-0.960195100904762 +-159.8115,54.7464222,13.719616,-373894.07153222,542259.760750577,69.8473510742188,13,1.84414994036196,-0.996937164004225 +-159.75422,54.7493169,13.719616,-370190.249260037,542259.776521207,64.311393737793,13,1.80828792158827,-1.12719825222949 +-159.69693,54.752183,13.719616,-366486.33601652,542259.786077889,53.999885559082,13,1.73239283943201,-1.40287085323417 +-159.63963,54.7550205,13.719616,-362782.326400199,542259.789869441,40.0399322509766,13,1.60249333396582,-1.87470293409754 +-159.46768,54.763361,13.719616,-351670.310656881,542259.779911886,19.7628765106201,13,1.29585015694037,-2.98851847773052 +-159.41035,54.7660839,13.719616,-347966.504994258,542259.795022179,49.8503684997559,13,1.69766837301516,-1.52900002660965 +-159.353,54.7687782,13.719616,-344261.934157474,542259.753834145,57.7705154418945,13,1.76170624243447,-1.29639620665103 +-159.29566,54.7714438,13.719616,-340558.518798534,542259.801289617,55.6126518249512,13,1.74517360440049,-1.35644746687514 +-159.2383,54.7740807,13.719616,-336854.328295009,542259.782404631,57.9524612426758,13,1.76307188519028,-1.29143580236866 +-159.18093,54.776689,13.719616,-333149.998060219,542259.760654439,62.7276496887207,13,1.79745901547705,-1.16653193010297 +-159.12356,54.7792686,13.719616,-329446.165259408,542259.775107421,66.1180648803711,13,1.82032013431146,-1.08349382128342 +-159.06618,54.7818195,13.719616,-325742.182717067,542259.775607494,62.9869613647461,13,1.7992506574949,-1.16002417490858 +-159.00879,54.7843417,13.719616,-322038.044982113,542259.762733259,73.1049575805664,13,1.86394682944593,-0.925029212256522 +-158.9514,54.7868352,13.719616,-318334.388327913,542259.785009309,79.2911682128906,13,1.89922481644734,-0.796889494127406 +-158.89399,54.7893001,13.719616,-314629.923028001,542259.757711501,78.9705429077148,13,1.89746512371668,-0.803281200391508 +-158.83658,54.7917362,13.719616,-310925.928726784,542259.75456835,83.2007522583008,13,1.92012725297524,-0.720965878508712 +-158.77917,54.7941436,13.719616,-307222.399137195,542259.785631554,88.9653472900391,13,1.94922087842823,-0.615289526716014 +-158.72174,54.7965224,13.719616,-303518.044556371,542259.769561967,94.2192916870117,120,1.97413983501601,-0.524776763810885 +-158.66431,54.7988724,13.719616,-299814.144566039,542259.776773624,100.557922363281,120,2.00241629177134,-0.422068601971223 +-158.60687,54.8011936,13.719616,-296110.051948008,542259.761667134,127.615310668945,120,2.10590278206652,-0.0461761312340593 +-158.54943,54.8034862,13.719616,-292406.401411307,542259.791151638,149.96208190918,120,2.17598146105994,0.208369633316458 +-158.49197,54.80575,13.719616,-288701.905570207,542259.755092486,172.71907043457,120,2.23734029198121,0.431242420776443 +-158.43452,54.8079851,13.719616,-284998.483363947,542259.795707926,191.306060791016,120,2.28172872918254,0.59247389441305 +-158.37705,54.8101914,13.719616,-281294.20487717,542259.772189048,205.180862426758,120,2.31213685093271,0.702924871951704 +-158.31958,54.812369,13.719616,-277590.347338928,542259.781634659,211.134185791016,120,2.32455855779075,0.74804405676823 +-158.2621,54.8145179,13.719616,-273886.263550227,542259.781867031,194.873321533203,120,2.28975238758365,0.621618111905979 +-158.20461,54.816638,13.719616,-270181.948740917,542259.762527911,185.860275268555,122,2.26918657602672,0.546917214264199 +-158.14712,54.8187293,13.719616,-266478.039132589,542259.764501884,151.285858154297,122,2.17979833309522,0.222233601992333 +-158.08963,54.8207919,13.719616,-262774.528534189,542259.79799528,102.515548706055,122,2.01078974056364,-0.391653845937364 +-158.03212,54.8228257,13.719616,-259070.128689792,542259.772991194,107.806747436523,122,2.03264594343647,-0.312265878721869 +-157.97461,54.8248307,13.719616,-255366.117542791,542259.768863411,116.125717163086,122,2.06492840910296,-0.195006749088105 +-157.9171,54.826807,13.719616,-251662.48892662,542259.795856875,135.607147216797,122,2.13228257975977,0.0496428235317377 +-157.85957,54.8287544,13.719616,-247957.955198645,542259.756225361,155.343292236328,122,2.19129250504743,0.263983715286043 +-157.80205,54.8306731,13.719616,-244254.434721748,542259.785032979,192.608596801758,122,2.2846756673173,0.603178014858373 +-157.74451,54.832563,13.719616,-240549.997458602,542259.760003925,238.027984619141,122,2.37662801945653,0.937175203642346 +-157.68697,54.8344241,13.719616,-236845.921345634,542259.754996013,281.986328125,221,2.45022805241933,1.20451153090413 +-157.62943,54.8362565,13.719616,-233142.200257525,542259.780318569,322.14013671875,221,2.50804483866484,1.41451860110156 +-157.57188,54.83806,13.719616,-229438.188174859,542259.778406668,339.290832519531,320,2.53057212536876,1.496344136338 +-157.51433,54.8398347,13.719616,-225734.520686316,542259.795257415,428.205017089844,320,2.63165175142565,1.86349418917426 +-157.45676,54.8415806,13.719616,-222029.908818175,542259.763238694,518.486267089844,320,2.71473725791679,2.16528446371466 +-157.3992,54.8432977,13.719616,-218326.272226611,542259.783567532,665.524719238281,420,2.82316419088419,2.55912203238004 +-165.47273,54.2809048,10.89546924,-744293.999575031,538555.740882237,45.1362075805664,10,1.65452506612801,-1.68570883154956 +-165.41676,54.2866167,13.719616,-740590.218870515,538555.774698901,181.539886474609,10,2.2589720595248,0.509815174815931 +-165.36077,54.292301,13.719616,-736886.203856122,538555.780914688,82.2283020019531,10,1.91502132225726,-0.739512076254132 +-165.30476,54.2979574,13.719616,-733181.955350462,538555.727702198,86.9170684814453,10,1.9391050701128,-0.652033029856804 +-165.24874,54.3035862,13.719616,-729478.105094429,538555.758833628,165.968643188477,10,2.22002604360282,0.36835212868764 +-165.1927,54.3091872,13.719616,-725774.009694771,538555.742496374,159.858993530273,10,2.20373707433119,0.309185942958377 +-165.13665,54.3147604,13.719616,-722070.30653657,538555.788489354,144.535934448242,10,2.15997583458341,0.150232629493057 +-165.08058,54.3203059,13.719616,-718366.34658652,538555.799017674,131.725250244141,10,2.11966903229357,0.00382681886960847 +-165.02449,54.3258236,13.719616,-714662.126803941,538555.764210636,98.2117309570312,10,1.99216336544097,-0.459310156879659 +-164.96839,54.3313135,13.719616,-710958.284563238,538555.792224908,86.2015075683594,11,1.93551486121792,-0.665073693310661 +-164.91227,54.3367755,13.719616,-707254.174486452,538555.765032546,77.803352355957,11,1.89099831007873,-0.826770513336909 +-164.85614,54.3422098,13.719616,-703550.43029348,538555.811636018,60.3825531005859,11,1.78091147195397,-1.22663733131795 +-164.79999,54.3476162,13.719616,-699846.408409206,538555.80417089,63.1447639465332,11,1.8003373440694,-1.15607701909878 +-164.74382,54.3529948,13.719616,-696142.102090934,538555.754752249,62.2807197570801,11,1.79435362291859,-1.17781160224257 +-164.68764,54.3583456,13.719616,-692438.148695585,538555.768800012,61.7579231262207,11,1.79069268256751,-1.19110918253411 +-164.63144,54.3636685,13.719616,-688733.902781471,538555.731118895,64.4819030761719,11,1.80943784646583,-1.12302139685297 +-164.57523,54.3689635,13.719616,-685030.001670802,538555.746029415,78.7448120117188,11,1.89622195053906,-0.807796760209544 +-164.51901,54.3742306,13.719616,-681326.440398385,538555.813039393,78.6447906494141,11,1.89566996068923,-0.809801744897728 +-164.46276,54.3794698,13.719616,-677621.929427667,538555.727598064,91.1434173583984,11,1.95972530811818,-0.577134439819378 +-164.40651,54.3846812,13.719616,-673918.388902907,538555.807996625,99.6566390991211,11,1.9985062365846,-0.43627103845032 +-164.35023,54.3898646,13.719616,-670213.890477358,538555.727374712,96.4853057861328,11,1.98446117757263,-0.487286701640769 +-164.29395,54.3950201,13.719616,-666510.354279229,538555.800696624,83.8372344970703,11,1.92343694398995,-0.708944136063433 +-164.23765,54.4001476,13.719616,-662806.492466199,538555.815252436,89.1116714477539,11,1.94993458970908,-0.612697123630486 +-164.18133,54.4052473,13.719616,-659102.296628022,538555.794265253,108.32373046875,11,2.03472360789661,-0.304719208378174 +-164.125,54.4103189,13.719616,-655398.409155175,538555.804703266,103.575981140137,11,2.01525905591413,-0.375420016914772 +-164.06865,54.4153626,13.719616,-651694.179356109,538555.770008801,109.08186340332,11,2.03775254821777,-0.293717232586061 +-164.01229,54.4203783,13.719616,-647990.246189894,538555.778034621,109.448112487793,11,2.0392082762447,-0.288429612886093 +-163.95591,54.4253661,13.719616,-644285.960684765,538555.742372839,81.8659057617188,11,1.91310307120603,-0.746479711595567 +-163.89952,54.4303258,13.719616,-640581.963426465,538555.738779862,78.0110549926758,11,1.89215615117914,-0.822564903979457 +-163.84312,54.4352575,13.719616,-636878.247711346,538555.777882651,81.9570541381836,11,1.91358633974229,-0.744724342333319 +-163.7867,54.4401613,13.719616,-633174.164585865,538555.774983165,82.9516067504883,11,1.91882480261008,-0.725696749991332 +-163.73027,54.4450369,13.719616,-629470.356193916,538555.793184316,98.4372711181641,11,1.99315956566922,-0.455691673306795 +-163.67382,54.4498846,13.719616,-625766.170309171,538555.770929421,103.231216430664,11,2.01381104490344,-0.380679606209108 +-163.61736,54.4547042,13.719616,-622062.247407921,538555.781225276,109.049842834473,11,2.03762504399844,-0.294180364304005 +-163.56088,54.4594958,13.719616,-618357.938533168,538555.741649444,100.574333190918,11,2.00248716187502,-0.421811181526328 +-163.5044,54.4642592,13.719616,-614654.526373416,538555.816657742,105.803382873535,11,2.02449955370883,-0.341855891423783 +-163.44789,54.4689947,13.719616,-610950.07423384,538555.761321507,95.1087265014648,11,1.97822036654374,-0.509955108602513 +-163.39138,54.473702,13.719616,-607246.508639022,538555.819984385,68.6025619506836,11,1.83634033466111,-1.02530388099309 +-163.33484,54.4783812,13.719616,-603541.896060794,538555.729067071,70.8398361206055,11,1.85027754783143,-0.974679944681786 +-163.2783,54.4830324,13.719616,-599838.156709123,538555.773632009,91.5046463012695,11,1.96144314665412,-0.570894759936929 +-163.22174,54.4876554,13.719616,-596134.00402746,538555.750194305,89.6298370361328,11,1.95245260679487,-0.603550966861282 +-163.16517,54.4922503,13.719616,-592430.073642317,538555.760404086,84.25341796875,11,1.92558752823605,-0.70113260024375 +-163.10859,54.496817,13.719616,-588726.361972454,538555.793009748,71.8651275634766,11,1.85651820080459,-0.952012111823576 +-163.05199,54.5013557,13.719616,-585022.218577565,538555.781735985,51.7846260070801,11,1.71420084408282,-1.46894937285487 +-162.99538,54.5058661,13.719616,-581318.285167962,538555.782517106,49.8379783630371,11,1.6975604172068,-1.52939215291926 +-162.93875,54.5103485,13.719616,-577613.909813934,538555.741240096,48.545539855957,11,1.68614933506945,-1.57084046028924 +-162.88212,54.5148026,13.719616,-573910.376447454,538555.799155511,67.244270324707,11,1.82765528536779,-1.05685045898631 +-162.82547,54.5192286,13.719616,-570206.392379162,538555.80473668,46.729248046875,11,1.66958879254324,-1.63099307759383 +-162.7688,54.5236263,13.719616,-566501.955418052,538555.737435894,83.8417129516602,11,1.92346014270566,-0.708859871706399 +-162.71213,54.5279959,13.719616,-562798.342042304,538555.79031003,93.6996841430664,11,1.97173812690534,-0.533500453184571 +-162.65544,54.5323373,13.719616,-559094.264003748,538555.78213804,138.713073730469,110,2.14211739533012,0.0853656808190672 +-162.59874,54.5366505,13.719616,-555390.35842926,538555.798085527,162.546722412109,110,2.21097821681778,0.335487839297489 +-162.54202,54.5409354,13.719616,-551685.979301812,538555.743922773,152.023315429688,110,2.18191019969435,0.229904504267095 +-162.4853,54.5451921,13.719616,-547982.404580707,538555.797265949,162.0751953125,110,2.20971655363197,0.330905118492105 +-162.42856,54.5494206,13.68009781,-544278.344532267,538555.792426626,136.77995300293,13,2.13602245017511,0.0632271003455223 +-162.37181,54.5536208,13.71072367,-540574.437670554,538555.80134772,74.8377304077148,13,1.87412060824604,-0.888075143768937 +-162.31504,54.5577928,13.719616,-536870.035122664,538555.754141772,46.7137107849121,13,1.66944436759607,-1.63151767022496 +-162.25827,54.5619365,13.719616,-533166.417662135,538555.801938885,110.209274291992,13,2.0422181426497,-0.277496919001758 +-162.20148,54.5660519,13.719616,-529462.295515722,538555.783553671,123.28736114502,13,2.09091855699866,-0.100603113604155 +-162.14468,54.5701391,13.719616,-525758.304398339,538555.790817217,103.019134521484,13,2.01291789698969,-0.383923774361621 +-162.08787,54.5741979,13.719616,-522054.441830475,538555.8016083,106.590118408203,13,2.02771694465576,-0.330169409169738 +-162.03104,54.5782285,13.719616,-518350.057602062,538555.759931002,91.7938766479492,13,1.96281371141144,-0.565916477540185 +-161.97421,54.5822307,13.719616,-514646.433758295,538555.80034316,101.807998657227,13,2.00778190016412,-0.402579180791542 +-161.91736,54.5862047,13.719616,-510942.277837447,538555.789382366,137.136703491211,110,2.13715370563115,0.0673361430543258 +-161.8605,54.5901503,13.719616,-507238.229557551,538555.783014761,97.7501373291016,110,1.99011737620836,-0.466741773755986 +-161.80363,54.5940675,13.719616,-503534.283665805,538555.781253915,122.540107727051,13,2.08827825779162,-0.110193433940553 +-161.74675,54.5979565,13.719616,-499830.432317069,538555.806224631,142.307281494141,110,2.15322712237396,0.125719380474081 +-161.68985,54.601817,13.719616,-496126.031882109,538555.750111792,117.021507263184,13,2.06826568762077,-0.18288480095728 +-161.63295,54.6056493,13.719616,-492422.357811972,538555.796084962,70.7028579711914,13,1.84943696932775,-0.977733165732137 +-161.57603,54.6094531,13.719616,-488718.124131455,538555.762197217,68.2243270874023,13,1.83393926081435,-1.03402526653921 +-161.5191,54.6132286,13.719616,-485013.965316181,538555.745330352,81.685173034668,13,1.91214323335495,-0.749966116635702 +-161.46217,54.6169757,13.719616,-481310.519657456,538555.806988792,83.7937088012695,13,1.92321141319522,-0.709763328282807 +-161.40522,54.6206945,13.719616,-477606.496078174,538555.812816528,119.94775390625,13,2.07899211995492,-0.143923337091078 +-161.34825,54.6243848,13.719616,-473901.891790181,538555.742479575,135.460876464844,13,2.13181388127044,0.0479403768386216 +-161.29128,54.6280467,13.719616,-470197.984837691,538555.750425993,125.294975280762,13,2.09793365478031,-0.0751222761529604 +-161.2343,54.6316802,13.719616,-466494.127658,538555.764867458,109.408164978027,13,2.03904973399542,-0.289005483587954 +-161.17731,54.6352853,13.719616,-462790.314969881,538555.785943854,87.5959396362305,13,1.94248397563785,-0.639759880554188 +-161.1203,54.638862,13.719616,-459085.899205665,538555.74467864,95.9840621948242,13,1.98219912600341,-0.495503118593973 +-161.06329,54.6424102,13.719616,-455382.160828264,538555.768985087,97.6610641479492,110,1.98972145219329,-0.468179882786685 +-161.00627,54.64593,13.719616,-451678.451064995,538555.800413368,96.9291305541992,110,1.98645431717136,-0.480047049719492 +-160.94923,54.6494214,13.719616,-447974.122340869,538555.771694898,104.275840759277,110,2.01818370017831,-0.364796874170688 +-160.89219,54.6528842,13.719616,-444270.456235684,538555.796361579,98.8329467773438,110,1.99490174436887,-0.449363583002381 +-160.83513,54.6563187,13.719616,-440566.159399275,538555.773467674,97.5164413452148,110,1.98907784424757,-0.470517650549516 +-160.77807,54.6597246,13.719616,-436862.514530814,538555.803267708,98.2352905273438,110,1.99226753389672,-0.458931787315759 +-160.72099,54.6631021,13.719616,-433158.229456552,538555.776006752,95.1460037231445,110,1.97839055197738,-0.509336946531749 +-160.6639,54.6664511,13.719616,-429453.942272223,538555.747197802,93.6755676269531,110,1.97162633338053,-0.533906519175722 +-160.60681,54.6697716,13.719616,-425750.289928098,538555.781202201,99.3857574462891,110,1.99732415194591,-0.440564707258618 +-160.5497,54.6730636,13.719616,-422045.982520242,538555.749510297,102.358016967773,110,2.01012186349596,-0.394079766078263 +-160.49259,54.6763271,13.719616,-418342.29927831,538555.780057489,98.1342697143555,110,1.99182069493191,-0.460554833976458 +-160.43546,54.6795621,13.719616,-414637.950293819,538555.746588552,98.9150161743164,110,1.99526222634555,-0.448054209571276 +-160.37833,54.6827686,13.719616,-410934.214791919,538555.774831398,92.0488357543945,110,1.96401829986187,-0.56154106846445 +-160.32119,54.6859466,13.719616,-407230.445143625,538555.802104908,90.8914031982422,110,1.95852280819309,-0.581502262774966 +-160.26403,54.689096,13.719616,-403525.994765725,538555.756893024,88.3489685058594,13,1.94620148338632,-0.626256831329377 +-160.20687,54.6922169,13.719616,-399822.141809715,538555.772688297,89.8397216796875,13,1.95346839782638,-0.59986132389918 +-160.1497,54.6953092,13.719616,-396118.239668948,538555.777438642,83.2434997558594,13,1.92035033070233,-0.720155596531207 +-160.09252,54.698373,13.719616,-392414.281941718,538555.782580603,80.2427291870117,13,1.90440569133218,-0.778071077776754 +-160.03533,54.7014082,13.719616,-388710.264281994,538555.777403499,80.6019058227539,13,1.90634531076936,-0.771025826358425 +-159.97813,54.7044149,13.719616,-385006.180302878,538555.773369427,78.3410034179688,13,1.89398912983753,-0.815907002307991 +-159.92092,54.707393,13.719616,-381302.025635052,538555.759789572,75.0372543334961,13,1.87527693451776,-0.883875036701667 +-159.86371,54.7103425,13.719616,-377598.437171706,538555.793925168,70.815788269043,13,1.8501300937592,-0.975215539959722 +-159.80648,54.7132635,13.719616,-373894.12398039,538555.773003451,71.4492492675781,13,1.85399766992669,-0.961167399403236 +-159.74925,54.7161558,13.719616,-370190.367187025,538555.788440368,63.499454498291,13,1.80276999443529,-1.14724093862233 +-159.69201,54.7190196,13.719616,-366486.517176948,538555.805988305,57.0188941955566,13,1.75601879050019,-1.31705465543672 +-159.63475,54.7218547,13.719616,-362781.928181943,538555.749298981,43.5383262634277,13,1.63887172951607,-1.7425662180312 +-159.5775,54.7246613,13.719616,-359078.519757428,538555.804890249,36.9988250732422,13,1.5681879329235,-1.99930994241957 +-159.52023,54.7274392,13.719616,-355374.361525087,538555.787180668,39.2409973144531,13,1.59374003649231,-1.9064974089612 +-159.46295,54.7301885,13.719616,-351670.089421039,538555.762371689,38.2506103515625,13,1.58263836942953,-1.94682183246447 +-159.40567,54.7329092,13.719616,-347966.340322486,538555.783358094,51.5865173339844,13,1.71253620913543,-1.4749958021179 +-159.34838,54.7356013,13.719616,-344262.466536793,538555.79713953,53.3400382995605,13,1.72705332318891,-1.42226550027877 +-159.29108,54.7382647,13.719616,-340558.463539036,538555.793146273,64.7640075683594,13,1.81133371486475,-1.11613506169338 +-159.23377,54.7408995,13.719616,-336854.325012003,538555.783004252,65.082878112793,13,1.81346675017856,-1.10838726860471 +-159.17645,54.7435057,13.719616,-333150.0455414,538555.767260417,56.3441696166992,13,1.75084898277256,-1.33583287271351 +-159.11913,54.7460832,13.719616,-329446.262852009,538555.7849858,70.3263778686523,13,1.84711824982964,-0.986155416777736 +-159.0618,54.748632,13.719616,-325742.329213192,538555.786026421,73.8154983520508,13,1.86814755616068,-0.90977097382176 +-159.00446,54.7511522,13.719616,-322038.238338717,538555.782059524,81.5497512817383,13,1.9114226408253,-0.75258351438096 +-158.94711,54.7536437,13.719616,-318333.985635268,538555.76258284,83.1741943359375,13,1.9199886027822,-0.721469495584538 +-158.88976,54.7561065,13.719616,-314630.207934807,538555.775577371,82.9163818359375,13,1.91864034283125,-0.726366760558109 +-158.8324,54.7585407,13.719616,-310926.256690583,538555.78426723,84.3458862304688,13,1.92606390576362,-0.699402261091934 +-158.77503,54.7609461,13.719616,-307222.12807477,538555.76708452,91.3560256958008,13,1.9607371979954,-0.573458966963203 +-158.71766,54.7633229,13.719616,-303518.45730568,538555.792571762,94.5763168334961,120,1.97578239690678,-0.518810510189754 +-158.66027,54.765671,13.719616,-299813.955165548,538555.758319668,103.803810119629,120,2.01621329458721,-0.371953949687303 +-158.60288,54.7679904,13.719616,-296109.900761789,538555.755841824,120.79517364502,120,2.08204958245391,-0.132817760608046 +-158.54549,54.7702811,13.719616,-292406.288632233,538555.784142512,143.977386474609,120,2.15829428584174,0.144124764501514 +-158.48809,54.7725431,13.719616,-288702.471029112,538555.798766186,162.854522705078,122,2.21179982405278,0.338472151285062 +-158.43068,54.7747763,13.719616,-284998.443228936,538555.789310826,181.46989440918,122,2.25880458652671,0.509206865085325 +-158.37326,54.7769809,13.719616,-281294.19827131,538555.77869734,204.519882202148,221,2.31073553391284,0.697834888559851 +-158.31584,54.7791567,13.719616,-277590.374445862,538555.787242394,218.075759887695,221,2.33860739445502,0.799073441470074 +-158.25841,54.7813038,13.719616,-273886.323256614,538555.783873847,211.517608642578,122,2.32534652782444,0.750906188839637 +-158.20097,54.7834222,13.719616,-270182.039231945,538555.769342214,197.326934814453,122,2.29518636980818,0.641355886358432 +-158.14353,54.7855118,13.719616,-266478.159876584,538555.773428675,104.303398132324,122,2.01829845766984,-0.364380042206422 +-158.08608,54.7875727,13.719616,-262774.036718842,538555.76677291,107.549095153809,122,2.0316067608754,-0.316040486395898 +-158.02863,54.7896048,13.719616,-259070.30724128,538555.778063779,109.729469299316,122,2.04032327876287,-0.284379605486705 +-157.97117,54.7916082,13.719616,-255366.322988501,538555.779082164,125.152565002441,122,2.09743975490302,-0.0769162614803349 +-157.9137,54.7935829,13.719616,-251662.078481537,538555.770639613,165.780471801758,122,2.21953337127921,0.366562602185625 +-157.85623,54.7955288,13.719616,-247958.211169846,538555.77978667,254.873733520508,122,2.40632508076198,1.04504340668895 +-157.79875,54.7974459,13.719616,-244254.073258866,538555.768905189,363.485748291016,221,2.56048738751993,1.60500490713697 +-157.74127,54.7993343,13.719616,-240550.300893972,538555.786174477,477.884338378906,221,2.67932279769578,2.03664903589862 +-157.68378,54.8011938,13.719616,-236846.247540743,538555.77289436,500.953765869141,320,2.69979764571863,2.11101952802106 +-157.62628,54.8030247,13.719616,-233141.905833511,538555.76327167,522.5234375,320,2.71810577525895,2.17751988017193 +-157.56878,54.8048267,13.719616,-229437.914391296,538555.759402282,699.232360839844,420,2.84462151946753,2.63706117432605 +-165.51889,54.2423544,13.11806432,-747998.386716502,534851.805783036,61.2502746582031,10,1.78710804050228,-1.20412962567374 +-165.46298,54.2480895,13.719616,-744294.469016488,534851.817586908,108.493263244629,10,2.03540277204154,-0.302252290351035 +-165.40705,54.253797,13.719616,-740590.319404662,534851.798707276,122.634063720703,10,2.08861111970233,-0.108984384472606 +-165.3511,54.2594767,13.719616,-736885.936836201,534851.728274267,119.838340759277,10,2.078595787304,-0.145362930403803 +-165.29514,54.2651287,13.719616,-733181.957384374,534851.72869257,75.4996566772461,10,1.87794497674817,-0.874183945785748 +-165.23917,54.270753,13.719616,-729478.376186874,534851.79934925,80.536247253418,10,1.90599138892793,-0.772311371505837 +-165.18317,54.2763496,13.719616,-725773.902694404,534851.721071294,145.312438964844,10,2.16230279215465,0.158684803571628 +-165.12717,54.2819185,13.719616,-722070.460562651,534851.822794828,133.553512573242,10,2.12565531482924,0.0255707056942972 +-165.07114,54.2874595,13.719616,-718366.120083895,534851.755823724,103.21263885498,10,2.01373288187342,-0.380963516644063 +-165.0151,54.2929729,13.719616,-714662.15650173,534851.771048791,81.9203033447266,10,1.91339155179456,-0.745431867757479 +-164.95904,54.2984584,13.719616,-710957.927602263,534851.727951768,71.6001129150391,11,1.85491370720087,-0.957840090560366 +-164.90297,54.3039162,13.719616,-707254.067653252,534851.756082575,69.9816970825195,11,1.84498447007939,-0.993905913871991 +-164.84688,54.3093461,13.719616,-703549.932542372,534851.727016709,67.0410461425781,11,1.82634078262705,-1.06162510813708 +-164.79078,54.3147483,13.719616,-699846.156567368,534851.769215899,72.5185852050781,11,1.86044932267635,-0.937733155131455 +-164.73466,54.3201226,13.719616,-696142.095571954,534851.755385361,70.5454559326172,11,1.84846904463966,-0.981248944472491 +-164.67853,54.3254691,13.719616,-692438.385664401,534851.801921431,82.7496719360352,11,1.91776628067553,-0.729541603789873 +-164.62238,54.3307878,13.719616,-688734.379074341,534851.804611975,82.7493057250977,11,1.91776435868916,-0.729548584992946 +-164.56621,54.3360786,13.719616,-685030.072631603,534851.7536559,87.6910934448242,11,1.94295548545049,-0.638047222332363 +-164.51003,54.3413416,13.719616,-681326.102461938,534851.763812478,86.3617095947266,11,1.93632123093185,-0.662144728348847 +-164.45384,54.3465766,13.719616,-677622.467113168,534851.812641627,100.249366760254,11,2.00108163801645,-0.426916445357102 +-164.39763,54.3517838,13.719616,-673918.515277474,534851.820164872,102.797592163086,11,2.01198294226109,-0.387319796798567 +-164.3414,54.3569631,13.719616,-670214.243733995,534851.77661679,103.957061767578,11,2.01685399614486,-0.369626738755497 +-164.28516,54.3621145,13.719616,-666510.290347571,534851.783585865,105.246734619141,11,2.022208630314,-0.350177179088444 +-164.2289,54.367238,13.719616,-662806.007296288,534851.740832968,104.703804016113,11,2.01996246041042,-0.358335909298964 +-164.17263,54.3723336,13.719616,-659102.032438308,534851.748852228,103.486953735352,11,2.01488560314682,-0.376776503959693 +-164.11635,54.3774012,13.719616,-655398.362474378,534851.796236501,105.233009338379,11,2.02215199005405,-0.350382912679318 +-164.06005,54.3824409,13.719616,-651694.34786642,534851.795441471,105.630821228027,11,2.02379065623039,-0.344430809404965 +-164.00373,54.3874526,13.719616,-647989.985289976,534851.736751461,107.104629516602,11,2.02980824328807,-0.322573215621114 +-163.9474,54.3924364,13.719616,-644285.910902429,534851.729465017,108.735168457031,11,2.03637003163545,-0.298738927422552 +-163.89106,54.3973922,13.719616,-640582.121354166,534851.762211573,80.6188735961914,11,1.90643672591359,-0.770693780462121 +-163.8347,54.40232,13.719616,-636877.968772314,534851.738726206,88.8634719848633,11,1.94872327755678,-0.617096955110559 +-163.77833,54.4072198,13.719616,-633174.090964186,534851.755669044,80.5605392456055,11,1.90612236457892,-0.771835630557296 +-163.72195,54.4120916,13.719616,-629470.48289216,534851.812696095,86.5224380493164,11,1.93712874859006,-0.65921159372572 +-163.66555,54.4169354,13.719616,-625766.496673716,534851.815247892,100.745613098145,11,2.00322614415559,-0.419126986956733 +-163.60913,54.4217512,13.719616,-622062.127264852,534851.764675165,104.505584716797,11,2.01913949950813,-0.361325138192503 +-163.5527,54.4265389,13.719616,-618358.014054473,534851.744442628,104.319480895996,11,2.01836541730114,-0.364136825713357 +-163.49626,54.4312986,13.719616,-614654.150379206,534851.765254141,95.6780471801758,11,1.98081230264424,-0.500540456873254 +-163.4398,54.4360303,13.719616,-610949.888343879,534851.734824461,84.4375228881836,11,1.92653548408881,-0.697689354012994 +-163.38334,54.4407338,13.719616,-607246.511707992,534851.815398856,87.7079315185547,11,1.94303886883909,-0.637744350064971 +-163.32685,54.4454093,13.719616,-603542.083716669,534851.754414602,100.249412536621,11,2.00108183632612,-0.426915725039767 +-163.27036,54.4500568,13.719616,-599838.527832257,534851.82592689,78.9892654418945,11,1.8975680751371,-0.802907251447276 +-163.21384,54.4546761,13.719616,-596133.913540301,534851.736690834,47.2150344848633,11,1.67408031122181,-1.61467859974623 +-163.15732,54.4592673,13.719616,-592430.162711959,534851.768446098,55.6684875488281,11,1.74560942216699,-1.35486445235244 +-163.10078,54.4638304,13.719616,-588725.984563773,534851.741993046,51.3438758850098,11,1.71048864992047,-1.4824331216182 +-163.04423,54.4683654,13.719616,-585022.016834382,534851.746878122,45.2904052734375,11,1.65600620691016,-1.68032890546911 +-162.98767,54.4728723,13.719616,-581318.254417696,534851.782894487,45.1147079467773,11,1.65431815027702,-1.68646040898 +-162.93109,54.477351,13.719616,-577614.050854312,534851.751847728,41.3424987792969,11,1.61639672224928,-1.82420185942993 +-162.8745,54.4818016,13.719616,-573910.042363723,534851.752664345,19.9199752807617,11,1.2992887951602,-2.97602836223104 +-162.8179,54.486224,9.073520974,-570206.225303514,534851.774144917,14.5487823486328,11,1.16282664683405,-3.47169783512657 +-162.76128,54.4906183,10.68544291,-566501.950222598,534851.741847274,67.6347961425781,11,1.83017018536119,-1.04771562438634 +-162.70466,54.4949844,13.719616,-562798.499137314,534851.81575399,69.3545227050781,11,1.84107478728117,-1.00810699772973 +-162.64801,54.4993223,13.719616,-559093.938370533,534851.741486524,143.114227294922,110,2.15568281005985,0.134639139072312 +-162.59136,54.503632,13.719616,-555390.191292452,534851.773145434,145.264511108398,110,2.16215952680778,0.158164422939794 +-162.53469,54.5079135,13.719616,-551685.967061836,534851.742792357,153.600006103516,110,2.18639123295281,0.246180896076038 +-162.47801,54.5121668,13.719616,-547981.903359709,534851.734503056,160.773056030273,110,2.20621326706258,0.31818018173457 +-162.42132,54.5163919,13.719616,-544277.995022523,534851.748177571,150.04069519043,13,2.17620906771987,0.209196365670733 +-162.36462,54.5205888,13.719616,-540574.236883894,534851.783727112,158.990112304688,13,2.20137011611266,0.300588475111537 +-162.3079,54.5247574,13.719616,-536869.982320899,534851.749196333,120.239288330078,13,2.08004639709287,-0.140093901605384 +-162.25118,54.5288978,13.719616,-533166.510438115,534851.817792314,130.293258666992,110,2.11492194603135,-0.0134159533880878 +-162.19443,54.5330099,13.719616,-529461.888904765,534851.737571871,114.429183959961,110,2.05853680082408,-0.218222894703632 +-162.13768,54.5370938,13.719616,-525758.039680401,534851.760376636,123.427551269531,110,2.09141211292886,-0.0988103775907784 +-162.08092,54.5411494,13.719616,-522054.316093282,534851.794848973,104.6943359375,110,2.01992318657255,-0.358478563087954 +-162.02414,54.5451767,13.719616,-518350.070090347,534851.762912012,139.112945556641,110,2.14336754639903,0.08990658633 +-161.96735,54.5491757,13.719616,-514645.939299217,534851.743719298,136.628875732422,110,2.135542494704,0.0614837650815281 +-161.91055,54.5531464,13.719616,-510941.918503093,534851.737268392,130.881881713867,110,2.11687953030703,-0.00630544854863814 +-161.85374,54.5570889,13.719616,-507238.001169935,534851.754615315,141.054473876953,110,2.14938686538866,0.111770470985 +-161.79692,54.561003,13.719616,-503534.184712113,534851.773687369,101.122734069824,13,2.00484880317907,-0.41323302623047 +-161.74009,54.5648888,13.719616,-499830.462582812,534851.805562085,133.696182250977,110,2.12611900598295,0.0272549643152091 +-161.68324,54.5687463,13.719616,-496126.186712857,534851.775577102,80.6228790283203,110,1.90645830267076,-0.770615407521435 +-161.62638,54.5725754,13.719616,-492421.995988619,534851.748555908,86.0732803344727,13,1.9348683546563,-0.667421989673819 +-161.56952,54.5763762,13.719616,-488718.526725453,534851.809203673,75.3229446411133,13,1.87692728978846,-0.877880475300225 +-161.51264,54.5801487,13.719616,-485014.48800466,534851.809860126,80.1630630493164,110,1.90397430333356,-0.779638002118155 +-161.45575,54.5838928,13.719616,-481310.518676471,534851.813706348,82.6845703125,110,1.91742447384111,-0.730783143773865 +-161.39884,54.5876085,13.719616,-477605.97063039,534851.748922388,88.8335647583008,13,1.94857709004768,-0.617627949869671 +-161.34193,54.5912959,13.719616,-473902.123051052,534851.771065019,120.999885559082,13,2.0827849595637,-0.13014666104777 +-161.28501,54.5949548,13.719616,-470198.330287235,534851.785665748,123.548377990723,13,2.09183704812496,-0.097266891669957 +-161.22807,54.5985854,13.719616,-466493.941775452,534851.744728399,108.152137756348,13,2.03403510820978,-0.307220035758091 +-161.17113,54.6021876,13.719616,-462790.239147708,534851.778382906,99.6441802978516,13,1.99845193887859,-0.436468263216655 +-161.11417,54.6057614,13.719616,-459085.931439255,534851.746854404,110.884895324707,13,2.04487239083896,-0.267855931980512 +-161.05721,54.6093068,13.719616,-455382.299049732,534851.789122437,100.595344543457,110,2.00257788245081,-0.421481658500812 +-161.00023,54.6128237,13.719616,-451678.052180079,534851.756602207,98.4443588256836,110,1.99319083473447,-0.455578095136734 +-160.94325,54.6163123,13.719616,-447974.468874458,534851.808192419,113.097518920898,110,2.053453077686,-0.236688428180169 +-160.88625,54.6197724,13.719616,-444270.260490072,534851.786497316,114.418754577637,110,2.05849721625779,-0.218366677146942 +-160.82924,54.623204,13.719616,-440566.064546748,534851.75973846,113.582611083984,110,2.05531184820315,-0.229936843115956 +-160.77223,54.6266072,13.719616,-436862.517429336,534851.804986326,111.960388183594,110,2.04906439556137,-0.252629374311441 +-160.7152,54.629982,13.719616,-433158.328156301,534851.790355521,115.861366271973,110,2.06393864552399,-0.198601852913576 +-160.65816,54.6333283,13.719616,-429454.135382519,534851.771362201,112.480697631836,110,2.05107800128099,-0.24531538359749 +-160.60111,54.6366461,13.719616,-425749.933776735,534851.748262069,110.881278991699,110,2.04485822679004,-0.267907379848986 +-160.54406,54.6399355,13.719616,-422046.35975252,534851.795945378,109.841178894043,110,2.04076518541251,-0.282774474402495 +-160.48699,54.6431963,13.719616,-418342.124489318,534851.764888798,102.447143554688,110,2.01049985384769,-0.392706797231588 +-160.42992,54.6464287,13.719616,-414638.506152788,534851.804072142,106.317794799805,110,2.02660596006966,-0.334204822293006 +-160.37283,54.6496326,13.719616,-410934.214813782,534851.777297693,104.934997558594,110,2.02092035675119,-0.354856556378453 +-160.31574,54.652808,13.719616,-407230.530813169,534851.809192286,103.404922485352,110,2.01454121339371,-0.378027425841591 +-160.25863,54.6559549,13.719616,-403526.16312279,534851.776884899,101.743209838867,110,2.00750543482195,-0.403583381825357 +-160.20152,54.6590732,13.719616,-399822.393116618,534851.791716843,97.8627548217773,13,1.99061743692011,-0.464925410519362 +-160.14439,54.6621631,13.719616,-396117.927677625,534851.755226873,92.188591003418,13,1.96467717733512,-0.559147837419278 +-160.08726,54.6652244,13.719616,-392414.049203452,534851.765469809,83.6197204589844,13,1.92230871136886,-0.713042198972872 +-160.03012,54.6682571,13.719616,-388710.109470434,534851.762611905,83.449462890625,13,1.92142354575597,-0.716257373130328 +-159.97297,54.6712614,13.719616,-385006.101095717,534851.769199026,79.1213073730469,13,1.89829345477983,-0.800272465540891 +-159.91581,54.6742371,13.719616,-381302.020730031,534851.763465281,75.8986434936523,13,1.88023401399184,-0.865869509160464 +-159.85865,54.6771842,13.719616,-377598.505826839,534851.802674336,71.9883041381836,13,1.85726194280833,-0.949310628580908 +-159.80147,54.6801028,13.719616,-373894.264341634,534851.784055273,73.0448608398438,13,1.86358966602788,-0.926326531735471 +-159.74428,54.6829928,13.719616,-370189.93471363,534851.754370572,63.6219177246094,13,1.80360675569658,-1.14420158288589 +-159.68709,54.6858542,13.719616,-366486.154390162,534851.769246289,64.3497543334961,13,1.80854689324801,-1.12625759324345 +-159.62989,54.6886871,13.719616,-362782.274190993,534851.783923071,51.8564033508301,13,1.71480239174195,-1.46676438005811 +-159.57268,54.6914914,13.719616,-359078.289679009,534851.787780902,46.7533187866211,13,1.66981244471781,-1.63018070905913 +-159.51546,54.694267,13.719616,-355374.196376942,534851.770208261,59.5249633789062,13,1.77469913688928,-1.24920230544984 +-159.45823,54.6970141,13.719616,-351669.987026863,534851.753871221,61.0518035888672,13,1.785698498373,-1.20924948501066 +-159.401,54.6997326,13.719616,-347966.299998895,534851.780578813,65.9680862426758,13,1.81933388522793,-1.08707615945835 +-159.34376,54.7024225,13.719616,-344262.487045217,534851.797332894,64.0974731445312,13,1.80684090906613,-1.1324542147284 +-159.2865,54.7050838,13.719616,-340557.899916142,534851.753378213,64.890266418457,13,1.81217955723516,-1.11306272077657 +-159.22925,54.7077164,13.719616,-336854.462602209,534851.791999959,64.4872894287109,13,1.80947412277556,-1.12288963094173 +-159.17198,54.7103205,13.719616,-333150.239406474,534851.782091235,64.874397277832,13,1.81207333601832,-1.11344854655469 +-159.11471,54.7128959,13.719616,-329446.512339802,534851.802913951,73.0051651000977,13,1.86335358745083,-0.927184036510866 +-159.05742,54.7154426,13.719616,-325741.990274738,534851.755266763,84.9833374023438,13,1.92933378237789,-0.687525135913182 +-159.00013,54.7179608,13.719616,-322037.951774824,534851.760581146,83.2733154296875,13,1.92050585592952,-0.719590684514742 +-158.94284,54.7204502,13.719616,-318334.393932182,534851.784492793,86.1218719482422,13,1.93511346109521,-0.666531693127345 +-158.88553,54.7229111,13.719616,-314630.023131697,534851.764473469,88.7254409790039,13,1.94804816653495,-0.619549151037692 +-158.82822,54.7253433,13.719616,-310926.121279694,534851.774260063,90.0011367797852,13,1.95424799492899,-0.597029604703348 +-158.7709,54.7277468,13.719616,-307222.040081634,534851.766549653,91.1416397094727,13,1.95971683761455,-0.577165207106303 +-158.71358,54.7301216,13.719616,-303518.416924681,534851.787688317,97.9768905639648,122,1.99112365238567,-0.463086691460167 +-158.65624,54.7324678,13.719616,-299813.959889644,534851.757468071,103.59553527832,122,2.01534103875119,-0.375122231850348 +-158.5989,54.7347853,13.719616,-296109.950000779,534851.756305355,121.884674072266,122,2.08594910033297,-0.118653598638107 +-158.54156,54.7370741,13.719616,-292406.381798567,534851.783206369,153.464813232422,122,2.18600881518297,0.244791845583104 +-158.4842,54.7393343,13.719616,-288701.963387637,534851.76134802,163.451400756836,122,2.21338864677847,0.344243208919945 +-158.42684,54.7415657,13.719616,-284997.97649987,534851.756731215,180.819580078125,122,2.2572454563355,0.503543659210804 +-158.36948,54.7437685,13.719616,-281294.414178906,534851.790604418,196.877288818359,221,2.29419562010081,0.637757200633154 +-158.3121,54.7459425,13.719616,-277589.986748295,534851.756217555,230.427124023438,221,2.36253359940554,0.885980247069163 +-158.25472,54.7480879,13.719616,-273885.972970348,534851.76067463,220.928726196289,221,2.34425218856238,0.819576944852633 +-158.19734,54.7502045,13.719616,-270182.368810602,534851.780844808,210.351974487305,221,2.32294659291549,0.742188940240703 +-158.13995,54.7522925,13.719616,-266478.524541581,534851.797904943,109.732650756836,122,2.04033587036132,-0.284333869207139 +-158.08255,54.7543517,13.719616,-262774.436087467,534851.790419146,107.363403320312,122,2.03085626977541,-0.31876648428254 +-158.02514,54.7563822,13.719616,-259070.097271992,534851.770282175,118.270317077637,122,2.07287576113739,-0.166139698098953 +-157.96773,54.758384,13.719616,-255366.145462018,534851.776747407,150.241180419922,122,2.17678898711482,0.211302798438663 +-157.91031,54.760357,13.719616,-251661.932994422,534851.75995118,232.19775390625,122,2.36585801440841,0.898055471242105 +-157.85289,54.7623013,13.719616,-247958.09655917,534851.769163608,391.169036865234,221,2.59236447073018,1.72079157198197 +-157.79546,54.7642169,13.719616,-244253.98783549,534851.76676999,653.41650390625,221,2.81519009962962,2.5301578569112 +-165.6766,54.1921834,10.37352375,-759110.284539975,531147.792593918,69.5984497070312,10,1.84259956588671,-1.00256856661926 +-165.45324,54.2152717,9.035720304,-744294.524351247,531147.833809356,29.4176979064941,10,1.46860868383595,-2.36101019785297 +-165.39735,54.2209746,12.23435197,-740590.013811875,531147.74053369,85.2064819335938,10,1.93047263421404,-0.683388500983614 +-165.34145,54.2266499,13.719616,-736885.907467589,531147.726530619,102.867599487305,10,2.0122786052805,-0.386245864321447 +-165.28554,54.2322975,13.719616,-733182.202369457,531147.780227439,93.9211959838867,10,1.97276361420481,-0.529775590609676 +-165.22961,54.2379173,13.719616,-729478.25212869,531147.780211976,65.3564910888672,10,1.81528872740364,-1.10176932727913 +-165.17366,54.2435095,13.719616,-725774.048129531,531147.749478194,94.0698013305664,10,1.9734502268236,-0.527281617599491 +-165.1177,54.2490739,13.719616,-722070.232636932,531147.775915671,109.050018310547,10,2.03762574283695,-0.294177825923078 +-165.06172,54.2546106,13.719616,-718366.155509002,531147.761737146,85.3887100219727,10,1.93140045266454,-0.680018399545651 +-165.00573,54.2601196,13.719616,-714662.455270424,531147.81565991,67.275749206543,10,1.82785854291971,-1.05611216954224 +-164.94972,54.2656008,13.719616,-710958.485468564,531147.819103363,62.1214752197266,11,1.79324176051724,-1.18185020384142 +-164.89369,54.2710543,13.719616,-707254.239378097,531147.784158942,59.3290328979492,11,1.77326726911097,-1.25440325791643 +-164.83765,54.2764799,13.719616,-703550.359126417,531147.795957503,66.9467697143555,11,1.82572962647012,-1.06384500174039 +-164.78159,54.2818778,13.719616,-699846.192775176,531147.770529003,83.9290161132812,11,1.92391213197671,-0.707218117663351 +-164.72552,54.2872479,13.719616,-696142.380619738,531147.802878332,93.919807434082,11,1.9727571934606,-0.529798912585329 +-164.66943,54.2925902,13.719616,-692438.274337286,531147.788229196,98.9468078613281,11,1.99540178792521,-0.447547282079111 +-164.61333,54.2979046,13.719616,-688734.514170041,531147.820483773,97.1097793579102,11,1.98726296736751,-0.477109801395317 +-164.55721,54.3031913,13.719616,-685030.448239887,531147.817957433,88.2170715332031,11,1.9455526367786,-0.628613627407893 +-164.50107,54.3084501,13.719616,-681326.0751431,531147.759885368,96.4374542236328,11,1.98424573725891,-0.488069242352997 +-164.44492,54.313681,13.719616,-677622.033314286,531147.74950162,86.0502090454102,11,1.9347519297148,-0.667844878292306 +-164.38876,54.3188841,13.719616,-673918.316052713,531147.797327683,99.9049911499023,11,1.99958718567056,-0.432344722836521 +-164.33258,54.3240593,13.719616,-670214.276738399,531147.791010127,93.3341827392578,11,1.97004072902214,-0.539665886781959 +-164.27638,54.3292066,13.719616,-666509.910396393,531147.731779965,99.4125442504883,11,1.99744118877391,-0.440139596093657 +-164.22018,54.334326,13.719616,-662806.498847292,531147.820485971,99.1780014038086,11,1.99641535231118,-0.443865726929177 +-164.16395,54.3394175,13.719616,-659102.106911138,531147.757296283,97.5872116088867,11,1.98939290894142,-0.469373245653036 +-164.10771,54.3444811,13.719616,-655398.016401886,531147.742523125,104.882820129395,11,2.02070435631521,-0.355641131614585 +-164.05146,54.3495168,13.719616,-651694.222331314,531147.775766619,102.636123657227,11,2.01130024132024,-0.389799561477982 +-163.99519,54.3545246,13.719616,-647990.076308475,531147.759064882,95.8779754638672,11,1.98171885500123,-0.497247599956877 +-163.93891,54.3595044,13.719616,-644286.218396227,531147.77973044,95.3591613769531,11,1.97936242306979,-0.505806833324518 +-163.88261,54.3644562,13.719616,-640582.000169194,531147.740933708,105.39045715332,11,2.02280128835962,-0.348024475905287 +-163.8263,54.3693801,13.719616,-636878.05835809,531147.750885533,89.3970947265625,11,1.95132340509654,-0.607652549735862 +-163.76998,54.374276,13.719616,-633174.389588685,531147.798237942,97.3787307739258,11,1.98846410968952,-0.472746909641655 +-163.71364,54.379144,13.719616,-629470.343805007,531147.798869567,92.6218643188477,11,1.96671351834692,-0.551751265634815 +-163.65728,54.3839839,13.719616,-625765.919219396,531147.732119815,108.868873596191,11,2.03690372954749,-0.296800384273495 +-163.60092,54.3887959,13.719616,-622062.394356261,531147.808687264,111.009819030762,11,2.04536139466303,-0.2660797305159 +-163.54454,54.3935798,13.719616,-618358.480585409,531147.818359146,108.615173339844,11,2.03589049963092,-0.300480724535095 +-163.48814,54.3983357,13.719616,-614654.171246948,531147.773515817,108.647521972656,11,2.03601982540229,-0.300010976420202 +-163.43173,54.4030635,13.719616,-610950.106263155,531147.756529313,108.686965942383,11,2.03617746534935,-0.299438383137559 +-163.37531,54.4077634,13.719616,-607246.277421637,531147.789142856,107.727958679199,11,2.03232843054323,-0.313419176177313 +-163.31887,54.4124351,13.719616,-603542.040960041,531147.747177463,78.4909286499023,11,1.89481946738299,-0.812890979340962 +-163.26242,54.4170789,13.719616,-599838.030522358,531147.755409084,52.4201278686523,11,1.71949807598835,-1.44970831459347 +-163.20596,54.4216945,13.719616,-596134.245683449,531147.780551842,42.3585357666016,11,1.62694093917209,-1.78590225394715 +-163.14948,54.4262821,13.719616,-592430.034865892,531147.755192983,43.9000015258789,11,1.64246453533736,-1.72951612179941 +-163.09299,54.4308415,13.719616,-588726.039435561,531147.747396469,39.2413177490234,11,1.59374358284452,-1.90648452759774 +-163.03649,54.4353729,13.719616,-585022.251245836,531147.778983542,49.2091674804688,11,1.69204601771246,-1.54942202584901 +-162.97997,54.4398762,13.719616,-581318.023320803,531147.75120041,32.389762878418,11,1.51040776860383,-2.20918399132943 +-162.92344,54.4443514,13.719616,-577613.993952938,531147.752503525,37.8808937072754,11,1.57842021657093,-1.96214336762758 +-162.8669,54.4487984,13.69998189,-573910.15951297,531147.771687598,11.9104709625244,11,1.07592893464664,-3.78733512886764 +-162.6406,54.4663051,12.46238951,-559094.084467372,531147.76436903,75.7822113037109,11,1.87956727371527,-0.868291300151593 +-162.584,54.4706113,13.71193599,-555390.501291254,531147.811235953,162.080276489258,110,2.20973016887045,0.330954572924465 +-162.52738,54.4748894,13.719616,-551686.437366597,531147.804184899,148.816848754883,110,2.17265210397216,0.196276458080507 +-162.47074,54.4791393,13.719616,-547981.888978039,531147.733752128,150.560134887695,110,2.17770999517029,0.214648162578 +-162.4141,54.483361,13.719616,-544278.137763121,531147.76542609,157.505783081055,110,2.19729650424677,0.285791954090054 +-162.35744,54.4875545,13.719616,-540573.891758764,531147.734651688,158.20783996582,110,2.19922800109294,0.292807701939422 +-162.30078,54.4917198,13.719616,-536870.432596864,531147.804708733,159.326507568359,110,2.20228803652282,0.303922624041823 +-162.2441,54.4958569,13.719616,-533166.468308724,531147.813295433,154.088912963867,110,2.18777139139957,0.251194025491113 +-162.1874,54.4999657,13.719616,-529461.995089679,531147.75099369,151.165573120117,110,2.17945289495903,0.220978872083824 +-162.1307,54.5040463,13.719616,-525758.293176525,531147.788807463,141.496032714844,110,2.15074426322281,0.116700927358574 +-162.07398,54.5080986,13.719616,-522054.07194135,531147.756773184,147.598083496094,110,2.16908071837812,0.183304166227996 +-162.01725,54.5121227,13.719616,-518349.968234849,531147.745637048,142.600006103516,110,2.15411954410437,0.12896091092146 +-161.96051,54.5161185,13.719616,-514645.978203706,531147.744347849,142.600006103516,110,2.15411954410437,0.12896091092146 +-161.90376,54.5200861,13.719616,-510942.095312603,531147.763951761,140.400573730469,110,2.14736888249085,0.104440581110502 +-161.847,54.5240254,13.719616,-507238.315683982,531147.793417779,139.572189331055,110,2.14479889089966,0.0951056381026553 +-161.79022,54.5279363,13.719616,-503533.992000445,531147.745900574,119.231056213379,13,2.0763893911877,-0.153377190866363 +-161.73344,54.531819,13.719616,-499830.403225065,531147.795728774,139.103713989258,110,2.14333872556004,0.0898019008164873 +-161.67664,54.5356734,13.719616,-496126.258645142,531147.780817857,75.5295944213867,110,1.87811715263009,-0.873558553838754 +-161.61983,54.5394995,13.719616,-492422.196432339,531147.777046116,75.7145385742188,110,1.8791792799798,-0.869700604143268 +-161.56301,54.5432972,13.719616,-488718.212620416,531147.773429882,66.8071060180664,110,1.82482265918663,-1.06713936578829 +-161.50618,54.5470666,13.719616,-485014.300693362,531147.78109961,87.4589614868164,13,1.94180431610028,-0.642228597988785 +-161.44934,54.5508077,13.719616,-481310.455415638,531147.80014695,84.9477462768555,13,1.92915186122144,-0.688185925478894 +-161.39248,54.5545205,13.719616,-477606.02814972,531147.758758328,68.9551239013672,13,1.83856654316466,-1.01721765628504 +-161.33562,54.5582049,13.719616,-473902.301680219,531147.790382321,86.8832778930664,13,1.93893619741992,-0.65264642367842 +-161.27874,54.5618609,13.719616,-470197.983936747,531147.751865965,104.860527038574,13,2.02061203618687,-0.355976464671497 +-161.22186,54.5654886,13.719616,-466494.355236793,531147.79656275,105.499237060547,13,2.02324931895511,-0.346397100901816 +-161.16496,54.5690879,13.719616,-462790.124731307,531147.772516648,110.726387023926,13,2.04425112921929,-0.270112531508865 +-161.10805,54.5726588,13.719616,-459085.930540782,531147.750686014,117.836761474609,13,2.0712807982182,-0.17193305866919 +-161.05114,54.5762013,13.719616,-455382.410783267,531147.799809785,119.882034301758,110,2.0787541039644,-0.144787879105173 +-160.99421,54.5797154,13.719616,-451678.273376039,531147.782369986,121.688293457031,110,2.08524880064952,-0.121197286973832 +-160.93727,54.5832011,13.719616,-447974.1564323,531147.767686418,120.075096130371,110,2.07945294300097,-0.142249496255825 +-160.88032,54.5866584,13.719616,-444270.054663417,531147.755962463,125.650444030762,110,2.09916402766611,-0.07065321064834 +-160.82336,54.5900873,13.719616,-440565.962778378,531147.74741309,122.623634338379,110,2.08857418366948,-0.109118546686501 +-160.7664,54.5934878,13.719616,-436862.518883268,531147.808046412,123.140342712402,110,2.09040035794393,-0.102485360479667 +-160.70942,54.5968598,13.719616,-433158.432005574,531147.794910973,127.848197937012,110,2.10669461087993,-0.0432999829732923 +-160.65243,54.6002034,13.719616,-429454.339105658,531147.785662595,127.119827270508,110,2.10421329408356,-0.0523128338160585 +-160.59543,54.6035186,13.719616,-425750.234883191,531147.780562703,123.412170410156,110,2.09135799017814,-0.0990069668695654 +-160.53842,54.6068053,13.719616,-422046.115129166,531147.768812577,120.326614379883,110,2.08036169716487,-0.138948641748287 +-160.4814,54.6100635,13.719616,-418341.974510215,531147.750693962,116.536338806152,110,2.06646136984421,-0.189438598125318 +-160.42438,54.6132933,13.719616,-414638.450015567,531147.800009174,117.598617553711,110,2.07040221636322,-0.175124318738716 +-160.36734,54.6164946,13.719616,-410934.250602071,531147.780563593,118.716293334961,110,2.07451032822047,-0.160202483901314 +-160.31029,54.6196674,13.719616,-407230.014329095,531147.755666948,112.39005279541,110,2.05072787522564,-0.246587141366433 +-160.25324,54.6228118,13.719616,-403526.378207747,531147.797486407,104.5419921875,110,2.01929077190287,-0.360775673677372 +-160.19617,54.6259276,13.719616,-399822.052196322,531147.762128409,99.7599868774414,110,1.99895638334283,-0.434635976939769 +-160.1391,54.6290149,13.719616,-396118.316691521,531147.781986827,96.3248062133789,13,1.98373814397058,-0.489912966057732 +-160.08202,54.6320738,13.719616,-392414.521927614,531147.807743137,90.3977279663086,13,1.95615751516458,-0.590093682176355 +-160.02492,54.6351041,13.719616,-388710.021198836,531147.759083977,85.0319442749023,13,1.92958210943299,-0.686623141169483 +-159.96782,54.6381059,13.719616,-385006.094924051,531147.765094993,80.6978302001953,13,1.90686185758761,-0.769149580877385 +-159.91071,54.6410792,13.719616,-381302.094348741,531147.767086738,81.1804428100586,13,1.90945141590761,-0.759743565925634 +-159.85359,54.6440239,13.719616,-377598.015095195,531147.754387132,77.909797668457,13,1.89159207648878,-0.824613784257781 +-159.79647,54.6469402,13.719616,-373894.493235293,531147.805884379,75.4137649536133,13,1.87745062302881,-0.87597957959708 +-159.73933,54.6498278,13.719616,-370190.239518613,531147.775603426,64.0216903686523,13,1.80632713666357,-1.13432038273973 +-159.68218,54.652687,13.719616,-366485.889071684,531147.7541006,67.2388687133789,13,1.82762039787169,-1.05697718033003 +-159.62503,54.6555175,13.719616,-362782.082781225,531147.763203768,71.8664932250977,13,1.8565264536762,-0.951982135038291 +-159.56787,54.6583195,13.719616,-359078.169959858,531147.769810781,66.1081161499023,13,1.8202547814635,-1.08373120148078 +-159.5107,54.661093,13.719616,-355374.145238444,531147.774403767,69.6597595214844,13,1.84298197085904,-1.00117956261048 +-159.45352,54.6638378,13.719616,-351670.005071236,531147.75529843,73.2569808959961,13,1.86484901633198,-0.921752211976631 +-159.39634,54.6665541,13.719616,-347966.38562118,531147.787571498,75.4163818359375,13,1.877465692928,-0.875924841421851 +-159.33914,54.6692418,13.719616,-344261.995608062,531147.755300594,74.6544952392578,13,1.8730559634184,-0.891942237662814 +-159.28194,54.6719009,13.719616,-340558.116425364,531147.763246941,72.7131195068359,13,1.86161277695776,-0.933507157098451 +-159.22473,54.6745315,13.719616,-336854.098391883,531147.77064639,75.3698425292969,13,1.87719760789845,-0.876898602768266 +-159.16751,54.6771334,13.719616,-333149.937857,531147.755866105,69.1959686279297,13,1.84008079310351,-1.01171746829716 +-159.11029,54.6797067,13.719616,-329446.271925182,531147.780168012,80.7326354980469,13,1.90704913015685,-0.768469353453006 +-159.05306,54.6822514,13.719616,-325742.451784225,531147.793404691,86.6028442382812,13,1.93753215548971,-0.657746304722409 +-158.99582,54.6847675,13.719616,-322038.472019588,531147.796163277,87.1318817138672,13,1.94017709322752,-0.648139135918297 +-158.93857,54.687255,13.719616,-318334.327214953,531147.789042934,93.0506973266602,13,1.96871963210393,-0.5444644878675 +-158.88131,54.6897138,13.719616,-314630.012769387,531147.76155778,93.0791244506836,13,1.96885228944038,-0.543982638557328 +-158.82405,54.692144,13.719616,-310926.165826293,531147.772244976,94.2177810668945,13,1.97413287190655,-0.524802055811882 +-158.76678,54.6945456,13.719616,-307222.137564724,531147.773805843,95.3146057128906,13,1.97915945566963,-0.506544068854548 +-158.7095,54.6969185,13.719616,-303517.923349905,531147.755788375,99.6618957519531,122,1.99852914399079,-0.436187832212641 +-158.65222,54.6992628,13.719616,-299814.160348869,531147.775094883,105.200843811035,122,2.02201922328737,-0.350865159471319 +-158.59493,54.7015784,13.719616,-296110.200504924,531147.775035357,117.401824951172,122,2.06967484784911,-0.177766328793611 +-158.53763,54.7038654,13.719616,-292406.037601503,531147.767392482,164.736785888672,122,2.21679058839022,0.356600031864632 +-158.48033,54.7061237,13.719616,-288702.310358418,531147.785231681,179.07389831543,122,2.253032288006,0.488240229280066 +-158.42302,54.7083533,13.719616,-284998.369916136,531147.784670995,186.046310424805,122,2.26962106173709,0.548495390378833 +-158.3657,54.7105543,13.719616,-281294.21008203,531147.777531469,192.014587402344,122,2.28333422343111,0.598305507777548 +-158.30838,54.7127266,13.719616,-277590.469542446,531147.795239589,216.379440307617,221,2.3352159931021,0.786754903753931 +-158.25105,54.7148702,13.719616,-273886.499433178,531147.795622939,278.318389892578,320,2.44454190329777,1.18385781430608 +-158.19371,54.7169851,13.719616,-270182.294287949,531147.77943557,328.884246826172,221,2.51704307177906,1.44720275212384 +-158.13637,54.7190714,13.719616,-266478.491345784,531147.798675273,253.714950561523,221,2.40434605947661,1.03785503651157 +-158.07902,54.7211289,13.719616,-262774.443132824,531147.790667886,156.411376953125,221,2.19426833931375,0.274792794728971 +-158.02166,54.7231577,13.719616,-259070.143476126,531147.767309323,176.920272827148,221,2.24777760041966,0.46915370412935 +-157.9643,54.7251579,13.719616,-255366.229639115,531147.778962544,239.275543212891,221,2.37889831085545,0.945421550008898 +-157.90693,54.7271293,13.719616,-251662.054086063,531147.764659362,377.092712402344,221,2.57644813942224,1.66297891369831 +-157.84956,54.729072,13.719616,-247958.25406798,531147.773671014,624.209228515625,320,2.79533018512999,2.45802097886462 +-165.72245,54.1535445,11.97767144,-762814.430572573,527443.817223942,41.4313087463379,10,1.61732865215747,-1.82081682400411 +-165.66669,54.1593811,13.719616,-759110.049419566,527443.753110118,65.0387191772461,10,1.81317198000711,-1.10945795800319 +-165.61092,54.16519,7.743656125,-755406.096628643,527443.754018956,13.0603370666504,10,1.11595438553762,-3.64195126683052 +-165.38767,54.1881497,8.855832191,-740589.943719935,527443.734619239,12.211932182312,10,1.08678438382434,-3.74790503900055 +-165.33182,54.1938205,13.719616,-736886.120787557,527443.765738437,82.4363250732422,10,1.91611862313646,-0.735526366260046 +-165.27595,54.1994636,13.719616,-733182.053256404,527443.750999256,76.0864791870117,10,1.88130748809543,-0.861970344816241 +-165.22007,54.205079,13.719616,-729478.38022485,527443.801313183,69.9981155395508,10,1.84508634827439,-0.993535863188842 +-165.16417,54.2106668,13.719616,-725774.451013005,527443.817762497,85.0500259399414,10,1.92967445040681,-0.686287732395821 +-165.10825,54.2162269,13.719616,-722070.262633687,527443.790477662,90.8592071533203,10,1.95836894279734,-0.582061145809893 +-165.05232,54.2217592,13.719616,-718366.456016508,527443.817762414,76.876335144043,10,1.88579267142614,-0.845678878760302 +-164.99637,54.2272638,13.719616,-714662.380470977,527443.802402877,62.6299934387207,11,1.7967823662035,-1.16898971339942 +-164.9404,54.2327407,13.719616,-710958.031120593,527443.745518794,55.206657409668,11,1.74199145276444,-1.36800594989379 +-164.88442,54.2381899,13.719616,-707254.047042556,527443.754736594,57.1978645324707,11,1.75737981482315,-1.31211102662071 +-164.82843,54.2436112,13.71045949,-703550.426963365,527443.807579929,54.2837677001953,11,1.73466998332479,-1.394599616654 +-164.77242,54.2490049,13.719616,-699846.516596275,527443.831055439,54.7284774780273,11,1.73821336643067,-1.38172903783123 +-164.71639,54.2543707,13.719616,-696142.316438126,527443.793404088,68.3150329589844,11,1.83451628219904,-1.03192936017172 +-164.66035,54.2597088,13.719616,-692438.461942334,527443.822006099,82.9108734130859,11,1.91861149018401,-0.726471561608252 +-164.60429,54.265019,13.719616,-688734.307790496,527443.790705863,116.940498352051,11,2.06796494028872,-0.183977201109152 +-164.54822,54.2703015,13.719616,-685030.489466157,527443.825795352,99.2080688476562,11,1.99654699587901,-0.443387559915999 +-164.49213,54.2755561,13.719616,-681326.361607112,527443.802248866,100.676971435547,11,2.00293014262709,-0.420202148995515 +-164.43602,54.2807829,13.719616,-677621.917510181,527443.732252715,76.4206008911133,11,1.88321044820019,-0.855058250556853 +-164.37991,54.2859818,13.719616,-673918.441882159,527443.808994675,101.517967224121,11,2.00654291294613,-0.407079536009459 +-164.32377,54.2911529,13.719616,-670213.996160115,527443.73858146,95.0039825439453,11,1.97774181118997,-0.511693358240688 +-164.26763,54.2962962,13.719616,-666510.507270373,527443.825009865,73.3542098999023,11,1.86542504365756,-0.919659916315524 +-164.21146,54.3014115,13.719616,-662806.041799109,527443.744794648,101.554916381836,11,2.00670095290891,-0.406505489755536 +-164.15529,54.306499,13.719616,-659102.523222636,527443.820579174,95.593391418457,11,1.98042786958047,-0.501936827489 +-164.09909,54.3115586,13.719616,-655398.016398816,527443.743231692,97.579719543457,11,1.98935956556038,-0.469494358330117 +-164.04289,54.3165903,13.719616,-651694.448212926,527443.81009375,105.163505554199,11,2.0218650545879,-0.351425144191915 +-163.98667,54.3215941,13.719616,-647990.52576104,527443.823961396,111.080986022949,11,2.04563972615947,-0.265068751077096 +-163.93043,54.32657,13.719616,-644286.244050347,527443.786133016,115.720283508301,11,2.06340948897473,-0.200523900536793 +-163.87418,54.3315179,13.719616,-640582.243689366,527443.783376741,114.439414978027,11,2.05857562899635,-0.218081859699281 +-163.81792,54.3364379,13.719616,-636878.518012832,527443.826334164,113.773216247559,11,2.05604003530201,-0.22729185972763 +-163.76164,54.3413299,13.719616,-633174.419689854,527443.808319688,112.215682983398,11,2.05005355707327,-0.2490364573654 +-163.70534,54.346194,13.719616,-629469.942067355,527443.741672494,109.735687255859,11,2.04034788790137,-0.28429021807155 +-163.64904,54.3510301,13.719616,-625766.369660993,527443.805192797,108.505294799805,11,2.03545093123738,-0.302077362405742 +-163.59272,54.3558382,13.719616,-622062.409516431,527443.80955537,109.608268737793,11,2.03984331812407,-0.28612295952123 +-163.53638,54.3606183,13.719616,-618358.056590544,527443.756129097,108.092590332031,11,2.03379592440471,-0.308088819607981 +-163.48003,54.3653704,13.719616,-614653.949794247,527443.738846667,108.264625549316,11,2.03448657815528,-0.305580168053691 +-163.42367,54.3700945,13.719616,-610950.084078152,527443.757425334,117.175086975098,11,2.06883528455445,-0.180815862315023 +-163.3673,54.3747906,13.719616,-607246.454389759,527443.8115932,87.8089981079102,11,1.94353902192411,-0.635927651302271 +-163.31091,54.3794587,13.719616,-603542.411716295,527443.810209374,67.0865936279297,11,1.82663574080789,-1.06055373583485 +-163.2545,54.3840987,13.719616,-599837.952543924,527443.743682909,46.035717010498,11,1.66309491171641,-1.65458070629501 +-163.19809,54.3887106,13.719616,-596134.359697264,527443.792972037,31.2879543304443,11,1.4953771690253,-2.26377941915888 +-163.14166,54.3932945,13.719616,-592430.338643008,527443.788774468,42.9227523803711,11,1.63268756290438,-1.76502887630173 +-163.08522,54.3978504,13.719616,-588726.528270545,527443.821194634,44.7260322570801,11,1.65056037268,-1.70010972978889 +-163.02876,54.4023782,13.719616,-585022.281059324,527443.790915282,37.5637016296387,11,1.57476838226593,-1.97540787216062 +-162.97229,54.4068778,13.719616,-581318.237362716,527443.775922345,35.2231178283691,11,1.54682779557579,-2.07689605805664 +-162.91581,54.4113494,13.719616,-577614.389070399,527443.798067138,29.2999992370605,11,1.46686760904556,-2.36733427844386 +-162.85931,54.4157929,11.8692926,-573910.088624786,527443.759734425,19.8139247894287,11,1.29697051014547,-2.98444903510894 +-162.57664,54.4375884,9.70647954,-555390.003723501,527443.74604328,24.3401012420654,11,1.38632238033525,-2.65989753901683 +-162.52007,54.4418631,13.719616,-551686.10551487,527443.762900944,53.3991775512695,11,1.72753456812039,-1.42051748132665 +-162.46349,54.4461096,13.719616,-547982.36464978,527443.795955431,80.6561050415039,110,1.90663724569262,-0.769965435390641 +-162.40689,54.4503279,13.719616,-544278.132011901,527443.763157392,162.08154296875,110,2.20973356239197,0.330966899163228 +-162.35028,54.4545181,13.719616,-540574.045001552,527443.758531246,156.883605957031,110,2.19557756299809,0.279548268840165 +-162.29366,54.45868,13.719616,-536870.101253102,527443.75993687,151.582595825195,110,2.18064934000985,0.225324702007819 +-162.23703,54.4628138,13.719616,-533166.292818605,527443.789385973,153.451019287109,110,2.18596977754658,0.244650049745266 +-162.18038,54.4669193,13.719616,-529461.973332072,527443.745030765,148.169799804688,110,2.17075969409726,0.189402685267304 +-162.12373,54.4709966,13.719616,-525758.424149266,527443.797877942,139.01579284668,110,2.14306414094876,0.0888045311340838 +-162.06706,54.4750457,13.719616,-522054.35217995,527443.789008953,144.192276000977,110,2.15894199699923,0.146477436300711 +-162.01038,54.4790666,13.719616,-518350.39620272,527443.798133785,140.88264465332,110,2.14885749562506,0.109847648906438 +-161.95368,54.4830592,13.719616,-514645.908408112,527443.736710769,141.699035644531,110,2.1513668945969,0.11896250222596 +-161.89698,54.4870236,13.719616,-510942.170178656,527443.771334609,140.598587036133,110,2.14798095620661,0.106663807549366 +-161.84026,54.4909597,13.719616,-507237.889723486,527443.736547476,140.526184082031,110,2.14775725337167,0.105851255001731 +-161.78354,54.4948676,13.719616,-503534.348438644,527443.796738091,138.779418945312,110,2.1423250648132,0.0861199956563861 +-161.7268,54.4987471,13.719616,-499830.25580043,527443.777651253,115.650238037109,110,2.0631465309942,-0.201479038977765 +-161.67005,54.5025984,13.719616,-496126.247951103,527443.777810603,82.2752227783203,110,1.91526906691614,-0.73861219693972 +-161.61329,54.5064214,13.719616,-492422.320965923,527443.78622924,72.7235260009766,110,1.86167492749724,-0.933281408599544 +-161.55652,54.5102161,13.719616,-488718.469616816,527443.802979017,69.1761703491211,13,1.83995651543663,-1.01216888025563 +-161.49973,54.5139825,13.719616,-485014.044715945,527443.755110997,69.1209716796875,13,1.83960983468149,-1.01342812371085 +-161.44294,54.5177206,13.719616,-481310.328944464,527443.789341872,74.5142211914062,13,1.87223916664826,-0.89490907666898 +-161.38613,54.5214304,13.719616,-477606.029152254,527443.760271089,76.8879241943359,13,1.88585813606173,-0.845441092518368 +-161.32932,54.5251118,13.719616,-473902.429240618,527443.801350653,92.0900115966797,13,1.96421252765951,-0.560835577665299 +-161.27249,54.5287649,13.719616,-470198.234810296,527443.780488151,118.895164489746,13,2.07516419206087,-0.157827463801638 +-161.21565,54.5323896,13.719616,-466494.085781495,527443.758681861,133.835632324219,13,2.12657175514769,0.0288994785090178 +-161.1588,54.535986,13.719616,-462789.975683262,527443.747140143,125.115524291992,13,2.09731120014946,-0.0773832090384369 +-161.10194,54.5395541,13.719616,-459085.899267402,527443.746026309,120.893249511719,110,2.08240205121925,-0.131537493447735 +-161.04508,54.5430937,13.719616,-455382.497596304,527443.801961296,124.87385559082,110,2.096471521151,-0.0804331628290865 +-160.9882,54.546605,13.719616,-451678.475108865,527443.799552921,126.232772827148,110,2.10117212202553,-0.0633592387677189 +-160.93131,54.550088,13.719616,-447974.470506832,527443.808126928,127.472640991211,110,2.10541698365987,-0.0479406897076708 +-160.87441,54.5535425,13.719616,-444270.480831389,527443.805762267,133.144989013672,110,2.12432482616615,0.0207379911106904 +-160.8175,54.5569686,13.719616,-440566.499625482,527443.803739727,132.078308105469,110,2.12083149707208,0.00804922274563729 +-160.76058,54.5603664,13.719616,-436862.520467612,527443.813355849,132.298767089844,110,2.12155579695717,0.0106800866640522 +-160.70364,54.5637357,13.719616,-433157.896377873,527443.747494228,135.364440917969,110,2.1315045938815,0.0468169567625516 +-160.6467,54.5670766,13.719616,-429453.908835001,527443.748478925,138.308822631836,110,2.14084988436174,0.0807617191982719 +-160.58975,54.5703891,13.719616,-425749.908583914,527443.750792494,134.214065551758,110,2.1277980320134,0.0333536660995564 +-160.53279,54.5736731,13.719616,-422045.89141703,527443.743639352,131.362533569336,110,2.11847151602819,-0.000522902011427023 +-160.47583,54.5769287,13.719616,-418342.494877517,527443.80136901,128.336837768555,110,2.10835133403117,-0.0372822916121439 +-160.41885,54.5801559,13.719616,-414638.42574632,527443.79773704,127.791282653809,110,2.10650122921774,-0.0440024003670016 +-160.36186,54.5833546,13.719616,-410934.323737842,527443.78553044,127.568145751953,110,2.10574224294921,-0.0467592551305394 +-160.30486,54.5865249,13.719616,-407230.182459857,527443.776143875,120.370246887207,110,2.08051915129427,-0.138376723408421 +-160.24785,54.5896667,13.719616,-403525.997646193,527443.758835195,111.67448425293,110,2.04795395544319,-0.256662809771819 +-160.19084,54.59278,13.719616,-399822.407912062,527443.794151418,103.457077026367,110,2.01476020412089,-0.377231989014308 +-160.13381,54.5958649,13.719616,-396118.118972861,527443.77255913,96.223747253418,110,1.98328226568017,-0.491568846129129 +-160.07678,54.5989212,13.719616,-392414.415458409,527443.792120101,91.01220703125,13,1.95909964606579,-0.579407022975382 +-160.01973,54.6019491,13.719616,-388710.002063258,527443.756634356,87.1471939086914,13,1.94025340762971,-0.647861940227248 +-159.96268,54.6049485,13.719616,-385006.162377393,527443.77303334,83.7783355712891,13,1.92313172795901,-0.710052767805121 +-159.90562,54.6079194,13.719616,-381302.247091068,527443.78263001,80.7529678344727,13,1.90715849249477,-0.768072118226555 +-159.84855,54.6108617,13.719616,-377598.251828186,527443.774755174,77.6291580200195,13,1.89002487575195,-0.830306304657599 +-159.79147,54.6137756,13.719616,-373894.169265492,527443.771998417,78.953125,13,1.89736932425434,-0.803629171382587 +-159.73438,54.6166609,13.719616,-370189.995991828,527443.752630666,81.0964279174805,13,1.9090017251126,-0.761376971247631 +-159.67729,54.6195178,13.719616,-366486.368675182,527443.794453202,75.9163970947266,13,1.88033558878952,-0.865500560502988 +-159.62018,54.622346,13.719616,-362781.996888372,527443.75374418,75.0119247436523,13,1.87513030924104,-0.884407621557764 +-159.56307,54.6251458,13.719616,-359078.160331226,527443.774043213,74.8551177978516,13,1.87422149813779,-0.887708682885286 +-159.50595,54.627917,13.719616,-355374.211551283,527443.778477104,72.9848022460938,13,1.86323243562995,-0.927624094504471 +-159.44882,54.6306596,13.719616,-351670.145151407,527443.767539598,73.8613204956055,13,1.86841706771827,-0.908792030918353 +-159.39168,54.6333737,13.719616,-347965.954830239,527443.752825807,78.0624847412109,13,1.89244237082715,-0.821525272522674 +-159.33454,54.6360593,13.719616,-344262.279172619,527443.786693847,76.8105087280273,13,1.88542064152082,-0.847030197564328 +-159.27739,54.6387162,13.719616,-340558.47061359,527443.794539862,79.0541687011719,13,1.89792477618069,-0.801611611444317 +-159.22023,54.6413446,13.719616,-336854.521972474,527443.799086626,80.075325012207,13,1.90349871006732,-0.781365492608971 +-159.16306,54.6439444,13.719616,-333150.428735499,527443.789797191,78.8800659179688,13,1.89696726486163,-0.805089565856097 +-159.10588,54.6465157,13.719616,-329446.184639716,527443.778330342,91.7330017089844,13,1.96252560482689,-0.566962962889074 +-159.0487,54.6490583,13.719616,-325742.429950863,527443.792126533,91.4697723388672,13,1.96127759816128,-0.571496079315159 +-158.99151,54.6515724,13.719616,-322038.513600194,527443.803797855,95.0573883056641,13,1.97798587791561,-0.510806838229593 +-158.93431,54.6540578,13.719616,-318334.431854518,527443.791756204,99.5457153320312,122,1.99802257176974,-0.438027847109585 +-158.8771,54.6565147,13.719616,-314630.177636963,527443.778805595,99.9959716796875,122,1.99998250487479,-0.43090881065145 +-158.81989,54.6589429,13.719616,-310926.391129835,527443.790197328,98.4334106445312,122,1.99314253334748,-0.455753539560863 +-158.76267,54.6613425,13.719616,-307222.422131135,527443.789730477,100.014556884766,122,2.00006321514631,-0.430615647908282 +-158.70544,54.6637135,13.719616,-303518.265220281,527443.778054239,100.958442687988,122,2.00414264283875,-0.415798002144738 +-158.6482,54.6660559,13.719616,-299813.914975032,527443.755829868,105.585563659668,122,2.02360454270975,-0.345106826834 +-158.59096,54.6683696,13.719616,-296110.010697255,527443.757217926,114.08699798584,122,2.05723615252727,-0.222947220559624 +-158.53371,54.6706548,13.719616,-292405.90145754,527443.7594004,158.783294677734,122,2.2008048091055,0.298535118706848 +-158.47646,54.6729112,13.719616,-288702.228062957,527443.77324404,184.111770629883,122,2.26508155469736,0.532006605106226 +-158.4192,54.6751391,13.719616,-284998.338850582,527443.788173398,193.034973144531,221,2.28563599951399,0.60666621550284 +-158.36193,54.6773383,13.719616,-281294.229879441,527443.782706148,217.413238525391,221,2.33728598521246,0.794273705933327 +-158.30465,54.6795088,13.719616,-277589.895688977,527443.757573865,283.682006835938,320,2.45283179057315,1.21396905105967 +-158.24737,54.6816507,13.719616,-273885.974063129,527443.765865445,428.219879150391,320,2.63166682457664,1.86354893916096 +-158.19009,54.6837639,13.719616,-270182.460268595,527443.795560576,480.234527587891,320,2.68145338146409,2.04438792427426 +-158.13279,54.6858484,13.719616,-266478.060925897,527443.765502779,521.733825683594,320,2.71744899434459,2.17513426442706 +-158.07549,54.6879043,13.719616,-262774.057800407,527443.768387128,500.276519775391,320,2.69921011997059,2.10888546680766 +-158.01819,54.6899315,13.719616,-259070.446125661,527443.792227725,393.215942382812,320,2.594631117371,1.72902467954679 +-157.96087,54.69193,13.719616,-255365.932517812,527443.759250959,418.062896728516,320,2.62124162542868,1.82568164020748 +-157.90356,54.6938998,13.719616,-251662.443377519,527443.785630405,541.735412597656,420,2.73378722582732,2.23447938456787 +-165.6568,54.1265761,10.40430089,-759110.032596059,523739.746719667,16.5142593383789,10,1.21785910043323,-3.27180425582822 +-165.54534,54.1381573,5.538413986,-751702.501856831,523739.826513307,28.1698169708252,10,1.44978402523146,-2.42938673099695 +-165.4338,54.1496281,13.719616,-744294.052635487,523739.746171291,63.9494552612305,10,1.80583684939248,-1.13610124605026 +-165.37801,54.1553221,13.719616,-740590.116068822,523739.760065327,82.4953231811523,10,1.9164293282567,-0.73439779657927 +-165.3222,54.1609884,13.719616,-736885.937312539,523739.724993406,64.6520080566406,10,1.81058201837921,-1.11886543788438 +-165.26638,54.1666271,13.719616,-733182.154151018,523739.763376915,88.2846450805664,10,1.94588517541606,-0.62740575216065 +-165.21054,54.1722382,13.719616,-729478.117239856,523739.764777562,66.9838027954102,10,1.82596979961145,-1.06297262433885 +-165.15469,54.1778215,13.719616,-725774.469978271,523739.817645396,66.193733215332,10,1.82081687525799,-1.08168951638167 +-165.09881,54.1833772,13.719616,-722069.914745744,523739.725866838,76.8571548461914,10,1.8856843033983,-0.846072502368723 +-165.04293,54.1889052,13.719616,-718366.382087217,523739.805767577,73.9149169921875,10,1.86873209351851,-0.907647767294565 +-164.98702,54.1944055,13.719616,-714661.933586707,523739.732278933,58.3815803527832,11,1.7662758468905,-1.27979809897177 +-164.93111,54.1998781,13.719616,-710958.497914279,523739.829360463,46.787166595459,11,1.67012674535853,-1.6290390794217 +-164.76326,54.2161294,11.00442605,-699846.490269598,523739.824462914,11.6977729797363,11,1.06810318869729,-3.81576047184596 +-164.70727,54.221491,13.719616,-696141.904515717,523739.727956987,77.1419830322266,11,1.88729079876238,-0.840237252666975 +-164.65128,54.2268248,13.719616,-692438.308903147,523739.789003412,88.9476165771484,11,1.94913431530628,-0.615603948682522 +-164.59527,54.2321309,13.719616,-688734.407712505,523739.808998857,102.776054382324,11,2.01189194091409,-0.387650339665234 +-164.53924,54.2374092,13.719616,-685030.197802173,523739.778159922,121.688362121582,11,2.085249045707,-0.121196396855102 +-164.4832,54.2426596,13.719616,-681326.320505074,523739.789299614,102.20059967041,11,2.0094534440647,-0.396507656238501 +-164.42714,54.2478823,13.719616,-677622.122867915,523739.761882479,79.5468444824219,11,1.90062295643951,-0.791811050606977 +-164.37107,54.2530772,13.719616,-673918.246226132,523739.787628476,99.5301895141602,11,1.99795483100476,-0.438273900903148 +-164.31498,54.2582442,13.719616,-670214.042844947,523739.754192679,93.7499694824219,11,1.97197113502783,-0.53265410117654 +-164.25888,54.2633833,13.719616,-666510.152268167,523739.763175182,72.7843933105469,11,1.86203826632225,-0.931961658279862 +-164.20276,54.2684947,13.719616,-662805.921603198,523739.736325886,70.8190765380859,11,1.85015025937453,-0.975142292688998 +-164.14663,54.2735781,13.719616,-659101.995519824,523739.741189068,70.4451675415039,11,1.84785120635891,-0.983493109456809 +-164.09049,54.2786337,13.719616,-655398.365643058,523739.799340783,68.6925354003906,11,1.8369095462218,-1.02323634213551 +-164.03433,54.2836614,13.719616,-651694.384175241,523739.801269747,88.5979690551758,11,1.94742376660218,-0.621817149815013 +-163.97815,54.2886612,13.719616,-647990.046128763,523739.74826754,111.075592041016,11,2.04561863674038,-0.265145353866767 +-163.92196,54.2936331,13.719616,-644285.9910277,523739.738651226,109.906661987305,11,2.04102401796158,-0.28183432070613 +-163.86576,54.2985771,13.719616,-640582.213877955,523739.772060386,110.857597351074,11,2.04476546176792,-0.268244328887118 +-163.80954,54.3034932,13.719616,-636878.065167302,523739.752245835,114.534706115723,11,2.05893710580837,-0.216768872742255 +-163.75331,54.3083814,13.719616,-633174.184410155,523739.775883339,112.646102905273,11,2.05171617150582,-0.242997367188979 +-163.69706,54.3132416,13.719616,-629469.923705896,523739.736858388,111.571258544922,11,2.04755233203025,-0.258121620642347 +-163.6408,54.3180738,13.719616,-625765.922534672,523739.73074825,110.789443969727,11,2.04449838273813,-0.269214436155237 +-163.58453,54.3228781,13.719616,-622062.17425915,523739.768246539,114.574798583984,11,2.05908910245236,-0.21621677754714 +-163.52824,54.3276544,13.719616,-618358.030941309,523739.744939758,109.813270568848,11,2.04065482633054,-0.283175330087829 +-163.47194,54.3324028,13.719616,-614654.130471095,523739.765772094,110.647583007812,11,2.04394193161317,-0.271235625468073 +-163.41563,54.3371231,13.719616,-610950.470971962,523739.808450121,110.276649475098,11,2.04248356250645,-0.276532838323677 +-163.3593,54.3418155,13.719616,-607246.399726383,523739.803285139,63.2808723449707,11,1.80127245740485,-1.15268042055651 +-163.30295,54.3464798,13.719616,-603541.914814327,523739.729672879,56.3185997009277,11,1.75065184802112,-1.3365489223986 +-163.2466,54.3511162,13.719616,-599838.297094189,523739.791706755,52.7460784912109,11,1.72219017671028,-1.43992983636936 +-163.19023,54.3557245,13.719616,-596134.255572654,523739.785923489,38.9943008422852,11,1.59100113795954,-1.91644587019169 +-163.13385,54.3603047,13.719616,-592430.429673936,523739.802973739,51.9980239868164,11,1.71598684002081,-1.46246212583409 +-163.07745,54.3648569,13.719616,-588726.168273975,523739.765008074,42.4640808105469,11,1.62802172766186,-1.78197652166455 +-163.02104,54.3693811,13.719616,-585022.11081897,523739.761587611,35.2609329223633,11,1.5472937985383,-2.0752034022863 +-162.96462,54.3738772,13.719616,-581318.253733927,523739.781499672,27.8870391845703,11,1.44540240691352,-2.44530201936609 +-162.90818,54.3783452,13.719616,-577613.947401201,523739.737583194,28.8413562774658,11,1.46001567941666,-2.39222244259148 +-162.85174,54.3827852,13.719616,-573910.474266945,523739.815195728,37.0579261779785,11,1.56888111183499,-1.99679211876008 +-162.39969,54.4172926,12.65114704,-544277.979311276,523739.742310839,33.4070510864258,11,1.52383814120484,-2.16040104463257 +-162.34313,54.4214794,13.719616,-540574.058104928,523739.752835076,82.2097015380859,110,1.91492307150405,-0.73986895103338 +-162.28656,54.4256381,13.719616,-536870.275806311,523739.788534825,133.420379638672,110,2.12522217207392,0.0239974075757074 +-162.22997,54.4297685,13.719616,-533165.985512986,523739.746999955,141.430709838867,110,2.15054372109783,0.115972501120223 +-162.17338,54.4338708,13.719616,-529462.468327604,523739.811381445,145.012908935547,110,2.16140666451039,0.155429812187355 +-162.11677,54.4379448,13.719616,-525758.432789694,523739.799561528,139.301452636719,110,2.14395564527408,0.0920427293043171 +-162.06015,54.4419907,13.719616,-522054.515519083,523739.813878068,142.662338256836,110,2.15430933789383,0.129650296137313 +-162.00351,54.4460083,13.719616,-518350.069527167,523739.754186697,141.974090576172,110,2.15220909546421,0.122021616164082 +-161.94687,54.4499978,13.719616,-514646.375980882,523739.799231229,141.897201538086,110,2.15197383049235,0.121167066634961 +-161.89021,54.453959,13.719616,-510942.143333691,523739.771390842,142.119079589844,110,2.15265238619172,0.123631774614155 +-161.83354,54.4578919,13.719616,-507238.010887872,523739.748735597,140.079650878906,110,2.1463750506828,0.100830700315842 +-161.77686,54.4617967,13.719616,-503533.970828992,523739.753388888,140.060607910156,110,2.14631600700022,0.100616236807941 +-161.72017,54.4656731,13.719616,-499830.021866054,523739.752254302,122.462432861328,110,2.08800288295987,-0.111193673929263 +-161.66347,54.4695213,13.719616,-496126.156188786,523739.767479067,79.3263168334961,110,1.89941729021177,-0.796190374477529 +-161.60676,54.4733413,13.719616,-492422.36860229,523739.799130179,70.821662902832,13,1.85016611983872,-0.975084682956049 +-161.55003,54.4771329,13.719616,-488718.011917878,523739.751592892,69.0723495483398,13,1.83930422911349,-1.01453817036235 +-161.4933,54.4808963,13.719616,-485014.367403925,523739.794792924,71.1661911010742,13,1.85227372249333,-0.967429268544788 +-161.43655,54.4846314,13.719616,-481310.142070982,523739.771155406,74.5770797729492,13,1.87260537361735,-0.893578908431369 +-161.37979,54.4883382,13.719616,-477605.975200549,523739.754379192,83.8011779785156,13,1.92325012347483,-0.709622721498238 +-161.32303,54.4920166,13.719616,-473902.507295704,523739.804887508,99.6962051391602,13,1.99867862753444,-0.435644865315241 +-161.26625,54.4956668,13.719616,-470198.441630521,523739.801647594,131.335525512695,13,2.11838221616775,-0.000847264593272708 +-161.20946,54.4992886,13.719616,-466494.419917739,523739.794606089,141.093948364258,13,2.14950838690551,0.112211871819905 +-161.15266,54.5028822,13.719616,-462790.434494118,523739.806033132,139.376281738281,110,2.14418887428858,0.0928898836551612 +-161.09585,54.5064473,13.719616,-459086.483701078,523739.802916693,124.90926361084,110,2.09659464802893,-0.0799859308645597 +-161.03902,54.5099842,13.719616,-455381.914188168,523739.750042284,129.109024047852,110,2.11095659824799,-0.0278192283601922 +-160.98219,54.5134926,13.719616,-451678.013265084,523739.75211256,130.421737670898,110,2.11534998222212,-0.0118612037695438 +-160.92535,54.5169727,13.719616,-447974.128791228,523739.762321079,130.435516357422,110,2.11539586177837,-0.01169455612589 +-160.8685,54.5204245,13.719616,-444270.255511152,523739.780879921,133.834594726562,110,2.12656838814687,0.0288872486010133 +-160.81164,54.5238479,13.719616,-440566.389306044,523739.796946908,134.352569580078,110,2.12824597701241,0.0349807301921782 +-160.75477,54.5272429,13.719616,-436862.524887361,523739.810754047,136.749801635742,110,2.13592670503424,0.0628793266655135 +-160.69788,54.5306095,13.719616,-433158.012449309,523739.757321087,138.913711547852,110,2.14274511510891,0.0876457382246856 +-160.64099,54.5339477,13.719616,-429454.13572855,523739.76790854,143.479965209961,110,2.15679126269919,0.138665355442266 +-160.58409,54.5372575,13.719616,-425750.244914686,523739.777001629,141.846755981445,110,2.15181940798194,0.120606160000593 +-160.52718,54.5405389,13.719616,-422046.334709962,523739.784878713,142.180572509766,110,2.15284025864262,0.124314180979951 +-160.47026,54.5437919,13.719616,-418342.39981438,523739.791829746,138.924453735352,110,2.14277869777206,0.087767720042686 +-160.41333,54.5470165,13.719616,-414638.434925695,523739.798156328,135.960388183594,110,2.13341239587684,0.0537466381505296 +-160.35639,54.5502126,13.719616,-410934.4358026,523739.793097949,133.228118896484,110,2.12459589595125,0.0217225939411933 +-160.29944,54.5533804,13.719616,-407230.395002652,523739.799126027,126.998184204102,110,2.10379751154039,-0.0538230746889763 +-160.24248,54.5565196,13.719616,-403526.31037798,523739.783352969,117.645126342773,110,2.07057394046842,-0.174500567773667 +-160.18551,54.5596304,13.719616,-399822.174491281,523739.768274535,108.970039367676,110,2.03730710779496,-0.295335199343048 +-160.12853,54.5627128,13.719616,-396117.982029403,523739.754250667,105.325416564941,110,2.02253318544899,-0.348998302200879 +-160.07155,54.5657667,13.719616,-392414.373207665,523739.789663164,100.006401062012,13,2.00002779856941,-0.430744291024481 +-160.01455,54.5687922,13.719616,-388710.052644171,523739.767236864,90.2786865234375,13,1.95558523184377,-0.592172378543439 +-159.95755,54.5717891,13.719616,-385006.306042618,523739.782825804,86.6378631591797,13,1.93770773228738,-0.65710855967866 +-159.90054,54.5747576,13.719616,-381302.481535202,523739.799905082,81.635986328125,13,1.91188164427532,-0.750916282837855 +-159.84351,54.5776976,13.719616,-377597.930261053,523739.750953354,85.424430847168,13,1.93158209392959,-0.679358626625402 +-159.78648,54.5806091,13.719616,-373893.935895855,523739.750671433,86.9084091186523,13,1.93906180012117,-0.652190198816909 +-159.72945,54.5834921,13.719616,-370190.493083436,523739.797825483,86.9133682250977,13,1.93908658082009,-0.652100188245319 +-159.6724,54.5863466,13.719616,-366486.307435766,523739.780824446,82.6367034912109,13,1.91717298416341,-0.731696626065575 +-159.61534,54.5891726,13.719616,-362782.018107607,523739.756431328,83.1467666625977,13,1.91984536542692,-0.721989774542944 +-159.55828,54.5919701,13.719616,-359078.264251755,523739.779189981,80.5155639648438,13,1.90587983925858,-0.77271655174436 +-159.50121,54.5947391,13.719616,-355374.395989217,523739.794402551,73.4182662963867,13,1.86580412483151,-0.918282985291196 +-159.44413,54.5974795,13.719616,-351670.408865005,523739.79147937,74.1685256958008,13,1.87021964629584,-0.90224455101745 +-159.38704,54.6001914,13.719616,-347966.296581153,523739.782017263,75.4573211669922,13,1.87770138311989,-0.875068747372215 +-159.32994,54.6028748,13.719616,-344262.053767867,523739.76653844,77.2768402099609,13,1.88804935580607,-0.837481956970537 +-159.27284,54.6055296,13.719616,-340558.320450823,523739.78576675,78.7702941894531,13,1.89636246746522,-0.807286362626212 +-159.21573,54.6081559,13.719616,-336854.445840107,523739.798941298,85.5841827392578,13,1.93239350785706,-0.676411339640256 +-159.15861,54.6107536,13.719616,-333150.42542372,523739.795527744,90.2289505004883,13,1.95534590589368,-0.593041678704619 +-159.10148,54.6133227,13.719616,-329446.253795891,523739.776093487,96.2512359619141,13,1.98340631499085,-0.491118263625535 +-159.04434,54.6158633,13.719616,-325741.924704789,523739.752311629,99.910400390625,111,1.99961069940872,-0.432259314228063 +-158.9872,54.6183753,13.719616,-322038.078119335,523739.762172877,103.703002929688,122,2.01579133244411,-0.373486636631055 +-158.93005,54.6208588,13.719616,-318334.063288319,523739.767768638,105.685333251953,122,2.02401472117963,-0.343616941554824 +-158.8729,54.6233136,13.719616,-314630.520973715,523739.7949005,110.606407165527,122,2.04378028534153,-0.271822770865112 +-158.81573,54.6257399,13.719616,-310926.155090304,523739.771076797,114.413314819336,122,2.05847656830386,-0.218441676409129 +-158.75856,54.6281376,13.719616,-307222.250076832,523739.780036062,113.066368103027,122,2.05333344206626,-0.237122978898479 +-158.70138,54.6305067,13.719616,-303518.156000425,523739.775053253,111.547798156738,122,2.04746100216072,-0.258453356796616 +-158.6442,54.6328472,13.719616,-299814.511956382,523739.801936761,112.899635314941,122,2.05269253908206,-0.239450921469026 +-158.587,54.635159,13.719616,-296110.024261468,523739.75941389,127.247550964355,122,2.1046494325577,-0.0507286543916395 +-158.5298,54.6374423,13.719616,-292405.97497734,523739.760103119,154.03303527832,122,2.18761387343696,0.250621875290827 +-158.4726,54.6396969,13.719616,-288702.360205682,523739.780830493,264.995544433594,221,2.42323857188333,1.10647803403267 +-158.41539,54.641923,13.719616,-284998.528498425,523739.799921126,336.758758544922,221,2.52731889983159,1.48452749262397 +-158.35817,54.6441204,13.719616,-281294.475915866,523739.795895582,368.657531738281,320,2.56662311104248,1.62729160628072 +-158.30094,54.6462892,13.719616,-277590.196280055,523739.78059022,500.281829833984,320,2.69921472965507,2.10890221049741 +-158.24371,54.6484293,13.719616,-273886.32938569,523739.784889854,585.863830566406,420,2.76779668682762,2.35801145418757 +-158.18647,54.6505408,13.719616,-270182.224555987,523739.778299777,660.99853515625,420,2.82020049704349,2.54835705042818 +-158.01472,54.6567034,13.719616,-259070.363671724,523739.784679021,676.929870605469,420,2.83054367845374,2.58592643754811 +-157.95745,54.6587003,13.719616,-255365.898560361,523739.756930209,622.173583984375,420,2.79391156804983,2.45286815671583 +-165.98066,54.058391,8.399747334,-781334.174901857,520035.775516905,22.8765869140625,10,1.35939123013154,-2.75771916347227 +-165.64693,54.0937685,13.17214642,-759110.235264102,520035.78538655,59.1940231323242,10,1.77227785787677,-1.25799708192514 +-165.59125,54.0995683,12.39189461,-755406.244265296,520035.780299582,57.8267402648926,10,1.76212871150002,-1.29486167842025 +-165.53555,54.1053406,12.63949696,-751702.024068763,520035.743025725,73.9704895019531,10,1.8690584926683,-0.906462192418948 +-165.47984,54.1110853,13.719616,-747998.216876918,520035.776282183,91.6892318725586,10,1.96231833443853,-0.567715828100463 +-165.42411,54.1168024,13.719616,-744294.17280365,520035.767363516,72.6238021850586,10,1.86107898245575,-0.935446051089897 +-165.36837,54.1224919,13.719616,-740590.532104573,520035.828837489,57.908374786377,10,1.76274137651664,-1.29263630420789 +-165.3126,54.1281538,13.719616,-736885.999813742,520035.738175853,65.0073318481445,10,1.81296234128317,-1.11021942568539 +-165.25683,54.1337881,13.719616,-733182.506324947,520035.829325546,99.6391220092773,10,1.99842989200572,-0.436548343751744 +-165.20103,54.1393947,13.719616,-729478.113458647,520035.759533857,57.3177375793457,10,1.75828903978188,-1.30880846205197 +-165.14522,54.1449737,13.68244537,-725774.10464431,520035.761092552,36.1553421020508,10,1.55817247518617,-2.03568894361778 +-165.0894,54.150525,13.719616,-722070.476894926,520035.822467776,45.7283973693848,10,1.66018598104766,-1.6651467727754 +-165.03355,54.1560486,13.719616,-718365.935199252,520035.726754366,46.7210693359375,10,1.66951277420242,-1.63126919790549 +-164.9777,54.1615446,13.719616,-714662.408076458,520035.810545097,20.1625576019287,11,1.30454562112431,-2.95693406988187 +-164.92182,54.1670129,13.719616,-710957.957283438,520035.739495946,51.9750747680664,11,1.71579512275262,-1.4631584976737 +-164.86594,54.1724534,13.36344808,-707254.51497275,520035.824938178,38.1552505493164,11,1.58155430972714,-1.95075944672496 +-164.81003,54.1778663,12.53364384,-703550.137415413,520035.768794698,42.8447799682617,11,1.63189791682919,-1.76789709623425 +-164.75411,54.1832514,13.719616,-699846.113486138,520035.762718926,67.0088500976562,11,1.82613216530903,-1.06238286578146 +-164.69818,54.1886088,13.719616,-696142.436487223,520035.817175968,63.3433532714844,11,1.80170105033293,-1.15112364870912 +-164.64223,54.1939384,13.719616,-692438.45822991,520035.816430501,74.642822265625,11,1.87298805184261,-0.892188911889975 +-164.58626,54.1992403,13.719616,-688734.172028104,520035.772644745,103.342575073242,11,2.01427927902275,-0.378978846240451 +-164.53028,54.2045144,13.719616,-685030.219813108,520035.779189649,101.600730895996,11,2.0068968321896,-0.405794000298569 +-164.47428,54.2097607,13.719616,-681325.951584211,520035.733005289,87.663330078125,11,1.94281796423129,-0.638546738652952 +-164.41827,54.2149793,13.719616,-677622.005745556,520035.748324298,98.3027801513672,11,1.99256580051091,-0.457848397839224 +-164.36225,54.22017,13.719616,-673918.380845818,520035.802737174,100.509140014648,11,2.00220555705437,-0.422834050612938 +-164.30621,54.2253329,13.719616,-670214.425127873,520035.805869034,94.3913955688477,11,1.97493240714463,-0.521897915617109 +-164.25015,54.230468,13.719616,-666510.133650282,520035.758967196,92.9206085205078,11,1.96811204525469,-0.546671416726488 +-164.19408,54.2355753,13.719616,-662806.146540957,520035.763093044,70.9023590087891,11,1.85066068493563,-0.973288281361141 +-164.138,54.2406548,13.719616,-659102.458851859,520035.81784164,68.2652893066406,11,1.83419993509546,-1.0330784231464 +-164.0819,54.2457064,13.719616,-655398.42224056,520035.813139063,67.9134674072266,11,1.83195590448209,-1.04122938284425 +-164.02578,54.2507301,13.719616,-651694.031724665,520035.750270121,69.9060134887695,11,1.84451453644178,-0.995612846976228 +-163.96965,54.2557259,13.719616,-647989.927391182,520035.728102797,70.3781127929688,11,1.84743761693809,-0.984995384283369 +-163.91351,54.2606939,13.719616,-644286.102597511,520035.757265653,109.670608520508,11,2.04009025321152,-0.285226020801332 +-163.85735,54.265634,13.719616,-640581.90895113,520035.729952034,110.583824157715,11,2.0436916044296,-0.272144885249292 +-163.80118,54.2705462,13.719616,-636877.986529376,520035.743388491,112.063781738281,11,2.04946527421182,-0.251173268630843 +-163.745,54.2754305,13.719616,-633174.330333718,520035.797239631,103.240867614746,11,2.01385164560753,-0.380532132863254 +-163.6888,54.2802868,13.719616,-629470.291906328,520035.785395018,111.585060119629,11,2.04760605175265,-0.25792649527748 +-163.63259,54.2851153,13.719616,-625766.50807262,520035.825441986,110.597473144531,11,2.04374520461856,-0.271950194063954 +-163.57636,54.2899157,13.719616,-622062.333573635,520035.790399131,108.266342163086,11,2.03449346415312,-0.305555156144086 +-163.52012,54.2946883,13.719616,-618358.403649154,520035.807767251,109.352745056152,11,2.03882968950238,-0.289804747993626 +-163.46386,54.2994328,13.719616,-614654.072978133,520035.751693229,110.846832275391,11,2.04472328658018,-0.268397521206961 +-163.40759,54.3041495,13.719616,-610949.976849977,520035.748592459,91.3613586425781,11,1.96076254938018,-0.57336688349767 +-163.35131,54.3088381,13.719616,-607246.11495424,520035.76517777,58.9860496520996,11,1.77074931205758,-1.26354919663086 +-163.29502,54.3134987,13.719616,-603542.480660123,520035.812202716,52.5250663757324,11,1.72036660989467,-1.44655355154144 +-163.23871,54.3181314,13.719616,-599838.422298386,520035.810115228,45.4885330200195,11,1.65790193129943,-1.67344309339367 +-163.18238,54.322736,13.719616,-596133.937904836,520035.738331424,32.668872833252,11,1.51413415036942,-2.19564870914157 +-163.12605,54.3273126,13.719616,-592430.311012817,520035.787727887,49.1875610351562,11,1.69185528860459,-1.55011480840831 +-163.0697,54.3318612,13.719616,-588726.246413373,520035.779123177,43.8908882141113,11,1.64237436969401,-1.72984362915189 +-163.01334,54.3363818,13.719616,-585022.384112534,520035.802081852,31.6855278015137,11,1.50086094577957,-2.24386077676166 +-162.95696,54.3408743,13.719616,-581318.075463395,520035.757861756,33.0124168395996,11,1.51867732020064,-2.17914661956481 +-162.90057,54.3453388,13.719616,-577613.958951997,520035.745951047,28.8914928436279,11,1.46076998272338,-2.38948259768184 +-162.84417,54.3497752,13.719616,-573910.030979493,520035.755160035,18.0258865356445,11,1.2558966330625,-3.13364108032599 +-162.78776,54.3541835,13.71555894,-570206.286439372,520035.785328654,34.1472702026367,11,1.53335599108293,-2.12582949721053 +-162.67489,54.3629159,13.65954308,-562798.035621747,520035.749496607,13.6601333618164,11,1.13545493931757,-3.57111968948957 +-162.61844,54.36724,12.65184489,-559094.164208057,520035.769651214,15.7799406051636,11,1.19810536421572,-3.34355546404789 +-162.33599,54.3884386,13.69658307,-540573.929824337,520035.740569587,18.0789794921875,11,1.25717391212274,-3.12900163820748 +-162.27947,54.3925939,13.719616,-536870.317171634,520035.788525062,53.2477645874023,11,1.72630138022845,-1.42499677173706 +-162.22293,54.3967211,13.719616,-533166.191636757,520035.77839114,121.235847473145,11,2.08363105265118,-0.127073409455045 +-162.16638,54.40082,13.719616,-529462.195883023,520035.769451433,58.2795715332031,11,1.76551635021103,-1.28255680769351 +-162.10982,54.4048909,13.719616,-525758.320649181,520035.794788931,106.626800537109,110,2.02786637788464,-0.329626625029932 +-162.05324,54.4089335,13.719616,-522053.919783772,520035.742660066,145.544189453125,110,2.1629948718235,0.161198634468075 +-161.99666,54.4129479,13.719616,-518350.276893825,520035.781870927,143.723236083984,110,2.15752698725231,0.14133771701589 +-161.94006,54.4169342,13.719616,-514646.095330599,520035.766805595,141.723068237305,110,2.15144054603276,0.119230025263208 +-161.88345,54.4208922,13.719616,-510942.017649904,520035.754002672,141.247848510742,110,2.14998184136207,0.113931593543488 +-161.82683,54.424822,13.719616,-507238.03733358,520035.754528787,142.250534057617,110,2.1530539055616,0.125090207570589 +-161.7702,54.4287236,13.719616,-503534.149196845,520035.768420123,140.919708251953,110,2.14897173538418,0.110262600318856 +-161.71356,54.432597,13.719616,-499830.348052289,520035.795724111,130.099197387695,110,2.11427461730586,-0.0157672360851009 +-161.6569,54.4364421,13.719616,-496125.984916783,520035.75074529,102.703514099121,110,2.01158530365324,-0.388764133719618 +-161.60024,54.440259,13.719616,-492422.343444653,520035.794568578,79.5424194335938,13,1.90059879674147,-0.791898805526118 +-161.54356,54.4440476,13.719616,-488718.129556099,520035.767371198,71.8901214599609,13,1.85666921736235,-0.951463576581371 +-161.48687,54.447808,13.719616,-485013.98184648,520035.754999958,73.5373916625977,13,1.86650822158084,-0.915725504928422 +-161.43017,54.4515401,13.719616,-481309.89635737,520035.746505404,78.5654067993164,13,1.89523136355572,-0.811394854874724 +-161.37347,54.4552439,13.719616,-477606.51293034,520035.813916108,92.7967071533203,13,1.96753256576073,-0.548776251648467 +-161.31674,54.4589194,13.719616,-473901.891113799,520035.741605359,114.327087402344,13,2.05814913954359,-0.219630991123928 +-161.26001,54.4625666,13.719616,-470197.960889626,520035.745457862,132.274551391602,13,2.12147629729929,0.0103913212151806 +-161.20327,54.4661856,13.719616,-466494.070742464,520035.76476087,145.915924072266,110,2.16410268983271,0.165222545680261 +-161.14652,54.4697762,13.719616,-462790.217848941,520035.777557349,150.011627197266,110,2.1761249219351,0.208890724162827 +-161.08976,54.4733385,13.719616,-459086.395752022,520035.795072991,130.859634399414,110,2.11680570261572,-0.00657361179599925 +-161.03298,54.4768725,13.719616,-455381.954133138,520035.748917956,128.794509887695,110,2.10989735078547,-0.0316667174834135 +-160.9762,54.4803782,13.719616,-451678.177889307,520035.776982309,126.558464050293,110,2.10229119546357,-0.0592944446254038 +-160.91941,54.4838555,13.719616,-447974.41785404,520035.799278232,128.327529907227,110,2.10831983489592,-0.0373967054620989 +-160.8626,54.4873045,13.719616,-444270.022525834,520035.760184564,131.556213378906,110,2.119111364565,0.0018012105052257 +-160.80579,54.4907251,13.719616,-440566.277932547,520035.783214156,131.485473632812,110,2.11887777511027,0.000952746932571417 +-160.74896,54.4941174,13.719616,-436861.887514229,520035.746431721,136.081268310547,110,2.13379834835367,0.0551485277081851 +-160.69213,54.4974813,13.719616,-433158.137275169,520035.771140072,136.950881958008,110,2.13656483343746,0.0651971911659867 +-160.63529,54.5008168,13.719616,-429454.376851941,520035.791257803,141.780715942383,110,2.15161716505481,0.119871555963387 +-160.57843,54.504124,13.719616,-425749.954778748,520035.754015287,143.918716430664,110,2.15811727700811,0.143481817894412 +-160.52157,54.5074027,13.719616,-422046.158115239,520035.766330248,146.47721862793,110,2.16577008480258,0.17127900013275 +-160.4647,54.5106531,13.719616,-418342.334300488,520035.785968868,146.998352050781,110,2.1673124660457,0.176881369047204 +-160.40782,54.5138751,13.719616,-414638.47913478,520035.802165984,143.508163452148,110,2.15687660658486,0.138975348794594 +-160.35092,54.5170687,13.719616,-410933.942243453,520035.753360004,140.171600341797,110,2.14666003171755,0.101865832775709 +-160.29402,54.5202338,13.719616,-407230.009520315,520035.753116635,134.690582275391,110,2.1293372304014,0.038944473975712 +-160.23711,54.5233706,13.719616,-403526.028471446,520035.76148733,123.948249816895,110,2.09324039879056,-0.0921695214963603 +-160.18019,54.5264789,13.719616,-399821.995884212,520035.75667343,114.952201843262,110,2.0605172943458,-0.211029176943626 +-160.12326,54.5295588,13.719616,-396117.905395229,520035.750111538,111.679107666016,110,2.04797193521037,-0.256597502125473 +-160.06633,54.5326102,13.719616,-392414.397779106,520035.790186435,102.714515686035,110,2.01163182272947,-0.388595163156877 +-160.00938,54.5356332,13.719616,-388710.17654188,520035.769624919,93.9036407470703,13,1.97268243066559,-0.53007047239623 +-159.95243,54.5386278,13.719616,-385006.526511882,520035.806444092,92.9664154052734,13,1.96832608577531,-0.545893960462319 +-159.89546,54.5415939,13.719616,-381302.153210993,520035.773468215,93.5589904785156,13,1.97108552703221,-0.535870882194343 +-159.83849,54.5445315,13.719616,-377598.341434928,520035.786504192,97.677978515625,13,1.98979666313386,-0.467906695183179 +-159.78151,54.5474407,13.719616,-373894.439792141,520035.799091251,95.7344207763672,13,1.98106811401035,-0.499611276975724 +-159.72452,54.5503214,13.719616,-370190.443915237,520035.800590378,93.9020919799805,13,1.97267526772129,-0.530096490254417 +-159.66752,54.5531736,13.719616,-366486.348448561,520035.791455069,92.2183380126953,111,1.96481729096494,-0.558638904723355 +-159.61051,54.5559973,13.719616,-362782.148034484,520035.772150619,92.1221389770508,13,1.96436401326034,-0.560285338724801 +-159.5535,54.5587925,13.719616,-359078.482386075,520035.797223175,89.6334533691406,13,1.95247012910483,-0.603487320830111 +-159.49647,54.5615592,13.719616,-355374.055996474,520035.75846579,80.5778350830078,13,1.90621559484519,-0.771496991619632 +-159.43944,54.5642975,13.719616,-351670.152737381,520035.775047178,74.1503677368164,13,1.87011330918334,-0.90263079776171 +-159.3824,54.5670072,13.719616,-347966.124000637,520035.771236426,84.1621398925781,13,1.92511676924935,-0.702842531251437 +-159.32535,54.5696884,13.719616,-344261.963499313,520035.758644733,82.4034271240234,13,1.91594527419834,-0.736156019081995 +-159.2683,54.5723411,13.719616,-340558.310936961,520035.789088668,83.2030029296875,13,1.92013900095729,-0.720923206484725 +-159.21124,54.5749652,13.719616,-336854.516742049,520035.79962966,92.1103134155273,13,1.96430826004145,-0.560487850329348 +-159.15416,54.5775608,13.719616,-333149.929578,520035.751752056,102.195327758789,111,2.00943104085779,-0.396589031080501 +-159.09709,54.5801279,13.719616,-329446.479288212,520035.796522356,111.394180297852,111,2.04686250205359,-0.260627280014665 +-159.04,54.5826664,13.719616,-325742.226121813,520035.77293644,116.310157775879,111,2.06561764485203,-0.192503248120015 +-158.98291,54.5851764,13.719616,-322038.453983419,520035.791338196,121.212921142578,122,2.08354891753503,-0.127371747640587 +-158.92581,54.5876579,13.719616,-318334.51242047,520035.802728015,126.561676025391,122,2.10230221744753,-0.0592544096337019 +-158.8687,54.5901107,13.719616,-314630.397681117,520035.785534355,134.895294189453,122,2.12999679961112,0.0413402176052022 +-158.81158,54.5925351,13.719616,-310926.101908739,520035.773672875,143.180465698242,122,2.15588377063837,0.135369085253352 +-158.75446,54.5949308,13.719616,-307222.267207003,520035.780758908,150.889419555664,122,2.17865878788897,0.218094448544651 +-158.69733,54.597298,13.719616,-303518.24148676,520035.782262556,156.940460205078,122,2.19573492178049,0.280119840852513 +-158.64019,54.5996366,13.719616,-299814.020136362,520035.767752648,192.03776550293,122,2.28338664399889,0.598495914242035 +-158.58305,54.6019466,13.719616,-296110.242809835,520035.782493722,277.837249755859,221,2.44379047134732,1.18112839898199 +-158.5259,54.604228,13.719616,-292406.25901426,520035.781471884,443.273529052734,320,2.6466717973278,1.91805128303879 +-158.46874,54.6064808,13.719616,-288702.06332777,520035.765388189,544.030090332031,320,2.73562292121244,2.24114715416624 +-158.41158,54.608705,13.719616,-284998.295399583,520035.777870006,696.401245117188,320,2.84285953893444,2.63066115811056 +-158.35441,54.6109007,13.719616,-281294.304003067,520035.786714503,657.224853515625,320,2.81771397828798,2.53932530458507 +-166.08155,54.0136052,11.42769356,-788742.041681373,516331.749997251,31.7861938476562,10,1.50223852760264,-2.23885700637928 +-166.02605,54.0196205,13.719616,-785038.105052185,516331.760017498,64.4654006958008,10,1.80932668644056,-1.12342516179297 +-165.97053,54.0256083,13.719616,-781333.974892518,516331.730040026,94.5634307861328,10,1.975723220141,-0.519025457093789 +-165.915,54.0315687,12.53430879,-777630.2900978,516331.789056763,50.5159454345703,10,1.70342848546886,-1.50807765407804 +-165.85945,54.0375016,10.90743926,-773926.402284281,516331.808896905,41.9809608459473,10,1.62305237434446,-1.80002663130798 +-165.80388,54.043407,13.719616,-770222.306693135,516331.790541745,67.596061706543,10,1.82992139373837,-1.04861930657262 +-165.74829,54.0492849,13.719616,-766517.998561863,516331.734982495,56.5032577514648,10,1.75207348822116,-1.33138511941555 +-165.69269,54.0551353,13.719616,-762814.118754701,516331.758082791,66.8675231933594,10,1.8252152370121,-1.06571341107329 +-165.63707,54.0609582,13.719616,-759110.01687144,516331.744875652,86.4393844604492,10,1.93671166558763,-0.660726558237908 +-165.58144,54.0667535,13.719616,-755406.335697741,516331.799181766,97.0730438232422,10,1.98709864757934,-0.477706657767514 +-165.52579,54.0725213,12.25395299,-751702.422879142,516331.818113411,21.6524219512939,10,1.33550648180961,-2.84447538676341 +-165.41443,54.0839741,9.497096572,-744293.888884655,516331.721169513,20.2687187194824,10,1.30682629577509,-2.94865000858088 +-165.30302,54.0953166,8.302446105,-736886.313325887,516331.795335751,17.4867649078369,10,1.24270947142096,-3.18154061539874 +-165.24729,54.1009464,12.89448576,-733182.471048089,516331.817533865,78.9871826171875,10,1.89755662331262,-0.802948847742441 +-164.91256,54.1341451,11.21898156,-710958.345927138,516331.798084952,32.5110740661621,11,1.51203131749065,-2.2032867983655 +-164.85671,54.1395814,13.719616,-707253.888481552,516331.724530916,69.6723709106445,11,1.84306058957706,-1.00089399698664 +-164.80086,54.14499,13.719616,-703550.431551874,516331.815343673,72.3256378173828,11,1.85929227224534,-0.941935892551972 +-164.74498,54.1503709,13.719616,-699846.03336541,516331.752196492,67.7660598754883,11,1.83101223517405,-1.04465705912108 +-164.68909,54.155724,13.719616,-696141.982079732,516331.736608093,68.2027816772461,11,1.83380208788877,-1.03452351775798 +-164.63319,54.1610495,13.719616,-692438.2692339,516331.790034607,78.3825988769531,11,1.89421965897888,-0.815069654667033 +-164.57727,54.1663472,13.719616,-688734.247859949,516331.786339243,83.2602691650391,11,1.9204378105467,-0.719837844767221 +-164.52133,54.1716171,13.719616,-685029.913035083,516331.726721115,87.1312942504883,11,1.9401741651034,-0.648149771700846 +-164.46538,54.1768593,13.719616,-681325.903718747,516331.725962179,79.7353210449219,11,1.90165074720308,-0.788077821193002 +-164.40942,54.1820737,13.719616,-677622.216744652,516331.772632025,93.2367630004883,11,1.96958718724848,-0.541313279957569 +-164.35344,54.1872604,13.719616,-673918.199823204,516331.775794267,94.1033325195312,11,1.97360500354645,-0.526719424364411 +-164.29745,54.1924193,13.719616,-670214.495393373,516331.826628462,90.9727020263672,11,1.95891109410303,-0.58009189752221 +-164.24144,54.1975503,13.719616,-666510.454593039,516331.813364786,78.8777313232422,11,1.89695441095995,-0.805136254895859 +-164.18541,54.2026536,13.719616,-662806.069054501,516331.759236115,71.415153503418,11,1.85379037402618,-0.961920357282057 +-164.12937,54.207729,13.719616,-659101.982868385,516331.742786108,69.3349761962891,11,1.8409523707892,-1.00855164936968 +-164.07332,54.2127766,13.719616,-655398.189377485,516331.774610521,71.0541915893555,11,1.85158970267774,-0.9699138237537 +-164.01725,54.2177963,13.719616,-651694.039669509,516331.745206416,71.4964904785156,11,1.8542847242735,-0.960124736082181 +-163.96117,54.2227883,13.719616,-647990.171068177,516331.775433481,73.8750915527344,11,1.86849803210688,-0.908497945149388 +-163.90507,54.2277523,13.719616,-644285.937968438,516331.734935906,108.624450683594,11,2.03592759322485,-0.300345990014366 +-163.84896,54.2326885,13.719616,-640581.977696838,516331.743480543,108.830879211426,11,2.03675213771882,-0.297351009063841 +-163.79284,54.2375968,13.719616,-636878.28692152,516331.789731075,108.009864807129,11,2.03346342248371,-0.309296561490526 +-163.7367,54.2424772,13.719616,-633174.215015533,516331.778014118,75.3181838989258,11,1.87689983959497,-0.877980182238021 +-163.68055,54.2473297,13.719616,-629470.402609558,516331.804465785,80.0009994506836,11,1.90309541265701,-0.782830383915747 +-163.62438,54.2521543,13.719616,-625766.199070323,516331.77454941,100.835960388184,11,2.00361543898515,-0.417712957019972 +-163.5682,54.256951,13.719616,-622062.245022204,516331.783306973,106.779930114746,11,2.02848963228523,-0.327362787152463 +-163.512,54.2617197,13.719616,-618357.891412867,516331.726332997,107.863914489746,11,2.0328761772209,-0.31142960390156 +-163.4558,54.2664606,13.719616,-614654.421307158,516331.812138196,103.826522827148,11,2.01630830964059,-0.37160882789343 +-163.39957,54.2711734,13.719616,-610949.897532214,516331.729774742,67.2142562866211,11,1.82746139760677,-1.05755471467538 +-163.34334,54.2758583,13.719616,-607246.24878641,516331.778656007,61.8396415710449,11,1.79126696370185,-1.18902322953802 +-163.28709,54.2805153,13.719616,-603542.178787452,516331.775103096,65.1423263549805,11,1.81386326397848,-1.1069470173071 +-163.23083,54.2851442,13.719616,-599838.331222511,516331.788850475,55.8237342834473,11,1.74681888490163,-1.3504713384852 +-163.17455,54.2897452,13.719616,-596134.052315062,516331.751929051,54.0482521057129,11,1.73278165364329,-1.40145856904016 +-163.11826,54.2943182,13.719616,-592429.984186932,516331.743989353,56.8733444213867,11,1.75490876757073,-1.32108657554861 +-163.06196,54.2988632,13.719616,-588726.12177658,516331.764824245,60.0246391296387,11,1.77832955774235,-1.23601558068624 +-163.00565,54.3033802,13.719616,-585022.460019469,516331.814237489,54.8618850708008,11,1.73927072601335,-1.37788840602648 +-162.94932,54.3078691,13.719616,-581318.3497117,516331.793490784,49.4000015258789,11,1.69372696233824,-1.54331635517883 +-162.89298,54.31233,13.719616,-577614.429900524,516331.802075307,25.7093715667725,11,1.41009146099064,-2.5735614537054 +-162.83662,54.3167629,13.719616,-573910.04988213,516331.753409577,45.6310043334961,11,1.65926002765268,-1.66851009979938 +-162.78026,54.3211677,13.719616,-570206.497306964,516331.809710853,46.6430053710938,11,1.66878652575678,-1.63390713955203 +-162.72388,54.3255445,13.719616,-566502.474350311,516331.809580253,28.2571430206299,11,1.4511282497596,-2.4245041238309 +-162.55466,54.3385064,13.719616,-555390.122020217,516331.765448887,32.9000015258789,11,1.51719591809225,-2.18452749485674 +-162.49823,54.3427708,13.38285199,-551686.109208901,516331.75798109,20.2523040771484,11,1.30647443945529,-2.94992805116421 +-162.44179,54.3470072,13.6870461,-547982.246132383,516331.781060123,15.6689424514771,11,1.19503968549304,-3.35469088420049 +-162.38534,54.3512154,13.70053638,-544278.530495268,516331.812544931,28.6291427612305,11,1.45680834419201,-2.403872399592 +-162.32887,54.3553956,13.719616,-540574.308729604,516331.793032566,44.3403854370117,11,1.64679946398009,-1.71377042365719 +-162.27239,54.3595476,13.719616,-536870.22412734,516331.782912763,54.4455909729004,11,1.73596271616399,-1.38990404199937 +-162.2159,54.3636714,13.719616,-533166.27152756,516331.782135286,53.7579689025879,11,1.73044285172989,-1.40995376515018 +-162.1594,54.3677671,13.719616,-529462.44440361,516331.801698701,55.5873413085938,11,1.74497590262968,-1.35716557613641 +-162.10288,54.3718347,13.719616,-525758.091986817,516331.762411472,59.508617401123,11,1.77457986016165,-1.24963555256959 +-162.04636,54.3758741,13.719616,-522054.501741183,516331.812112775,84.776008605957,11,1.92827296541439,-0.69137832591192 +-161.98982,54.3798853,13.719616,-518350.377234059,516331.793020171,130.696670532227,110,2.11626452416892,-0.00853932638249748 +-161.93327,54.3838684,13.719616,-514646.357595885,516331.795348997,139.744369506836,110,2.14533431858799,0.097050464292974 +-161.87671,54.3878233,13.719616,-510942.438993638,516331.808075997,140.563171386719,110,2.14787154715126,0.106266402631879 +-161.82013,54.3917499,13.719616,-507237.971923665,516331.743805723,139.883666992188,110,2.14576700863576,0.09862211804851 +-161.76355,54.3956484,13.719616,-503534.239841622,516331.777980802,143.400131225586,110,2.15654954875522,0.137787381405752 +-161.70695,54.3995187,13.719616,-499829.947617587,516331.747408649,147.850387573242,110,2.169822467318,0.185998410093892 +-161.65035,54.4033607,13.719616,-496126.382603022,516331.792186542,137.882537841797,110,2.1395092683575,0.0758922192209672 +-161.59373,54.4071746,13.719616,-492422.2457806,516331.78451457,92.1270980834961,110,1.96438739151253,-0.56020042224003 +-161.5371,54.4109602,13.719616,-488718.180135208,516331.777642259,78.6087951660156,13,1.89547113991188,-0.81052391871016 +-161.48046,54.4147175,13.719616,-485014.180443152,516331.771661751,73.9534606933594,13,1.86895850186047,-0.906825387573185 +-161.42381,54.4184466,13.719616,-481310.240237465,516331.777729455,80.4610900878906,13,1.90558591210237,-0.773784179070908 +-161.36715,54.4221475,13.719616,-477606.354317645,516331.795963588,94.7211151123047,13,1.9764468021773,-0.516397200607072 +-161.31048,54.4258201,13.719616,-473902.518702581,516331.81543854,116.016914367676,110,2.06452131061518,-0.196485446993184 +-161.25379,54.4294644,13.719616,-470198.082528122,516331.765490668,118.005996704102,110,2.07190407738517,-0.169669130833156 +-161.1971,54.4330804,13.719616,-466494.331818832,516331.788429073,148.549835205078,110,2.17187217435197,0.193443531085891 +-161.14039,54.4366682,13.719616,-462789.968881638,516331.754427912,161.722183227539,110,2.20876959561781,0.327465496695974 +-161.08368,54.4402276,13.719616,-459086.282132829,516331.781472339,126.015281677246,110,2.10042321452766,-0.0660794845594914 +-161.02695,54.4437588,13.719616,-455381.972690331,516331.7530498,121.561805725098,110,2.08479714263052,-0.122837837814851 +-160.97022,54.4472616,13.719616,-451678.328927859,516331.784933074,118.41739654541,110,2.07341550871025,-0.164179180855024 +-160.91347,54.4507362,13.719616,-447974.051996318,516331.762867719,118.678955078125,110,2.07437371386824,-0.160698706222209 +-160.85672,54.4541824,13.719616,-444270.430226909,516331.800414222,114.658164978027,110,2.05940498692153,-0.21506939499272 +-160.79995,54.4576003,13.719616,-440566.16594053,516331.774511471,113.952529907227,110,2.05672397157477,-0.224807607970119 +-160.74317,54.4609898,13.719616,-436861.900639684,516331.741788968,116.208312988281,110,2.06523719652079,-0.193885145049859 +-160.68639,54.464351,13.719616,-433158.273550728,516331.778786264,122.53938293457,110,2.08827568904648,-0.11020276435608 +-160.62959,54.4676839,13.719616,-429453.988152898,516331.75476157,133.265411376953,110,2.12471744425731,0.0221640920821282 +-160.57279,54.4709884,13.719616,-425750.33154384,516331.788810963,140.176834106445,110,2.14667624721817,0.101924732102336 +-160.51597,54.4742645,13.719616,-422046.00716988,516331.752443645,146.379440307617,110,2.16548008226896,0.170225628155677 +-160.45915,54.4775123,13.719616,-418342.299916527,516331.784684544,146.068786621094,110,2.1645574216394,0.166874261395569 +-160.40231,54.4807317,13.719616,-414637.914324722,516331.748228131,147.811965942383,110,2.16970959327663,0.185588419358159 +-160.34547,54.4839227,13.719616,-410934.136355703,516331.768820705,146.649932861328,110,2.16628186848969,0.173137944561961 +-160.28862,54.4870853,13.719616,-407230.315077318,516331.783799406,142.050659179688,110,2.15244325338762,0.122872144577218 +-160.23176,54.4902195,13.719616,-403526.445185636,516331.793505828,129.553695678711,110,2.11244980628347,-0.0223954705713446 +-160.17489,54.4933254,13.719616,-399822.520341792,516331.809368817,124.805534362793,111,2.09623384407982,-0.0812964737914195 +-160.118,54.4964028,13.719616,-396117.891682229,516331.749956494,118.636428833008,111,2.07421806518265,-0.161264066674833 +-160.06112,54.4994518,13.719616,-392414.489745546,516331.805659365,107.66429901123,111,2.03207171710682,-0.314351632651655 +-160.00422,54.5024723,13.719616,-388710.373332453,516331.786847932,103.981758117676,111,2.01695715618614,-0.36925203204078 +-159.94731,54.5054645,13.719616,-385006.180740678,516331.775724385,100.80696105957,111,2.00349052263905,-0.418166688843696 +-159.89039,54.5084282,13.719616,-381301.908652834,516331.75054258,109.775604248047,111,2.04050583631043,-0.283716504366866 +-159.83347,54.5113635,13.719616,-377598.196376375,516331.779661897,114.291427612305,111,2.05801365751437,-0.220123100524465 +-159.77654,54.5142703,13.719616,-373894.393926629,516331.794462117,109.831474304199,111,2.04072681331877,-0.282913852799468 +-159.7196,54.5171486,13.719616,-370190.495952466,516331.795387283,108.681335449219,111,2.03615496628122,-0.29952010617491 +-159.66265,54.5199986,13.719616,-366486.495206023,516331.80506066,104.347717285156,111,2.0184829528619,-0.363709903008661 +-159.60569,54.52282,13.719616,-362782.389202809,516331.790701233,101.712181091309,111,2.00737296731752,-0.404064541611433 +-159.54872,54.525613,13.719616,-359078.170700535,516331.774956676,102.962745666504,111,2.01268011520861,-0.384787465660179 +-159.49175,54.5283775,13.719616,-355374.480917981,516331.800745695,100.687042236328,111,2.0029735832909,-0.420044360105334 +-159.43476,54.5311135,13.719616,-351670.023233443,516331.760990859,99.7846832275391,111,1.99906388296805,-0.434245507617528 +-159.37777,54.533821,13.719616,-347966.083544906,516331.762671796,103.989303588867,111,2.01698866976765,-0.369137565717835 +-159.32077,54.5365001,13.719616,-344262.009966963,516331.763892528,103.83667755127,111,2.01635078361428,-0.371454550297711 +-159.26377,54.5391506,13.719616,-340558.44455362,516331.794295113,109.486808776855,111,2.03936179752754,-0.287871979767498 +-159.20675,54.5417726,13.719616,-336854.08977585,516331.762399287,117.231513977051,111,2.06904437368379,-0.180056390917293 +-159.14973,54.5443662,13.719616,-333150.230662464,516331.781861242,125.283836364746,111,2.09789504361657,-0.0752625229203876 +-159.0927,54.5469312,13.719616,-329446.217944104,516331.779793087,143.381072998047,111,2.15649182612246,0.137577716327879 +-159.03566,54.5494677,13.719616,-325742.045375674,516331.767870974,156.717041015625,111,2.19511622312248,0.27787255073242 +-158.97862,54.5519756,13.719616,-322038.354045204,516331.784090775,168.333618164062,122,2.22617085825232,0.39067184939935 +-158.92157,54.5544551,13.719616,-318334.491269052,516331.801641099,177.85578918457,122,2.25006800598508,0.477473110889773 +-158.86451,54.556906,13.719616,-314630.453325044,516331.798955734,198.305465698242,122,2.29733468440134,0.649159178150806 +-158.80744,54.5593283,13.719616,-310926.234803845,516331.776665804,185.664886474609,122,2.26872977637169,0.545257987533533 +-158.75037,54.5617221,13.719616,-307222.475129723,516331.792771548,244.322265625,221,2.38796304698753,0.97834725897391 +-158.69329,54.5640874,13.719616,-303518.523288166,516331.80055399,284.319915771484,221,2.45380728180343,1.21751231364095 +-158.6362,54.5664241,13.719616,-299814.374669426,516331.789584389,333.2021484375,320,2.52270779300949,1.46777863650518 +-158.5791,54.5687322,13.719616,-296110.023857487,516331.760541714,612.099426269531,320,2.78682197242829,2.42711672184636 +-166.07135,53.9808292,11.11645163,-788742.014381586,512627.742270028,49.2931747436523,10,1.69278678993903,-1.54673132968467 +-166.0159,53.9868398,13.71942075,-785038.414900361,512627.812933292,59.3813629150391,10,1.77365016125747,-1.25301248435206 +-165.96042,53.992823,13.719616,-781333.971213906,512627.733651035,126.167526245117,10,2.1009475879717,-0.0641748105396606 +-165.90493,53.9987787,13.719616,-777629.972957806,512627.730318105,98.2424087524414,10,1.99229900215895,-0.458817485605383 +-165.84943,54.004707,13.719616,-773926.413405894,512627.813175368,68.1408920288086,10,1.83340781459513,-1.03595563089727 +-165.7939,54.0106078,13.719616,-770221.997415598,512627.738644381,68.2617645263672,10,1.83417751034402,-1.03315987624426 +-165.73836,54.0164811,13.719616,-766518.012602338,512627.740234359,91.8136138916016,10,1.96290708206875,-0.565577328662201 +-165.68281,54.0223269,13.719616,-762814.454201601,512627.81727745,87.0837097167969,10,1.93993692146251,-0.64901150832066 +-165.62723,54.0281452,13.719616,-759110.025068957,512627.740506095,72.515022277832,10,1.86042798473034,-0.937810660641803 +-165.57164,54.033936,10.17873921,-755406.012808901,512627.740112828,24.2948436737061,10,1.38551410892011,-2.66283341150025 +-165.46041,54.045435,13.61592797,-747997.9293338,512627.729704551,35.1277923583984,10,1.54565085697414,-2.08117103498954 +-165.40478,54.0511431,13.71673071,-744294.496626551,512627.821792531,54.3355178833008,10,1.73508381076879,-1.3930964772593 +-165.34912,54.0568237,11.46360606,-740590.169255908,512627.765842545,32.2480125427246,10,1.50850295406198,-2.21610282143362 +-165.18206,54.0737,11.43067109,-729478.242444589,512627.780932819,45.4251861572266,10,1.65729671576853,-1.67564140894762 +-165.12634,54.0792702,6.657805152,-725774.172985756,512627.766697646,16.6346321105957,10,1.22101320050962,-3.26034766408099 +-164.90331,54.1012748,12.88565847,-710958.374480507,512627.80298146,61.2598190307617,11,1.78717570951173,-1.20388383251676 +-164.84751,54.1067068,13.719616,-707254.199172719,512627.772632433,72.3095550537109,11,1.85919568917442,-0.942286709833104 +-164.7917,54.1121112,13.719616,-703550.37511969,512627.808552092,79.6752624511719,11,1.90132350271882,-0.789266466564697 +-164.73587,54.1174878,13.719616,-699846.254859851,512627.782913823,86.2078018188477,11,1.93554657131833,-0.664958513175014 +-164.68003,54.1228368,13.719616,-696142.476110403,512627.823660004,80.9451446533203,11,1.90819080350927,-0.764322469971015 +-164.62417,54.128158,13.719616,-692438.391366125,512627.804093601,81.9585418701172,11,1.91359422323581,-0.744695707234688 +-164.56829,54.1334515,13.719616,-688733.993947802,512627.736384036,79.2254104614258,11,1.89886449791813,-0.798198273870645 +-164.5124,54.1387174,13.719616,-685029.923397858,512627.735867386,80.2853012084961,11,1.9046360410649,-0.777234381799167 +-164.4565,54.1439554,13.719616,-681326.180076997,512627.769153712,85.5073699951172,11,1.9320035487664,-0.677827782362918 +-164.40058,54.1491657,13.719616,-677622.109373764,512627.755717153,85.9064712524414,11,1.93402588005208,-0.670482097902513 +-164.34465,54.1543483,13.719616,-673918.352572991,512627.798273356,82.3000030517578,11,1.9153998513163,-0.738137150668773 +-164.2887,54.1595031,13.719616,-670214.260295444,512627.784494735,78.5442581176758,11,1.89511444196727,-0.811819547456722 +-164.23274,54.1646301,13.719616,-666510.473791625,512627.815997644,71.1833801269531,11,1.85237860653422,-0.967048299771385 +-164.17676,54.1697293,13.719616,-662806.341932469,512627.79257068,66.4145278930664,11,1.82226308981481,-1.07643645232057 +-164.12077,54.1748008,13.719616,-659102.504274123,512627.825724715,70.7631988525391,11,1.8498074569766,-0.976387448843843 +-164.06476,54.1798444,13.719616,-655398.313065783,512627.794408144,73.5652694702148,11,1.86667283013472,-0.915127599676763 +-164.00874,54.1848602,13.719616,-651694.407847824,512627.809035816,72.3498306274414,11,1.85943751876323,-0.941408315741499 +-163.9527,54.1898481,13.719616,-647990.139138163,512627.760675647,77.2275619506836,11,1.88777232451754,-0.838488213683107 +-163.89665,54.1948083,13.719616,-644286.144838492,512627.769646143,104.623008728027,11,2.01962720522679,-0.359553651817242 +-163.84059,54.1997406,13.719616,-640582.423299168,512627.81361392,104.318542480469,11,2.01836151054743,-0.364151016157907 +-163.78451,54.204645,13.719616,-636878.323340683,512627.796340893,88.9942092895508,11,1.94936174871893,-0.614777845611791 +-163.72842,54.2095215,13.719616,-633174.486156611,512627.814513987,79.2743225097656,11,1.89913253916929,-0.797224671539851 +-163.67231,54.2143702,13.719616,-629470.258947457,512627.784032754,77.1395568847656,11,1.88727713980545,-0.84028686589721 +-163.61619,54.219191,13.719616,-625766.284532669,512627.789491868,89.3040542602539,11,1.95087117560622,-0.609295176323838 +-163.56005,54.2239839,13.719616,-622061.911720104,512627.736926745,96.0820159912109,11,1.98264210684982,-0.493894085720499 +-163.50391,54.2287488,13.719616,-618358.429464685,512627.802941338,92.7013549804688,11,1.96708608210825,-0.550398007713377 +-163.44774,54.2334859,13.719616,-614653.891010923,512627.729937788,74.7636337280273,11,1.87369040118299,-0.889637778615278 +-163.39157,54.238195,13.719616,-610950.233072158,512627.774972321,64.229377746582,11,1.80773371459491,-1.12921129021581 +-163.33538,54.2428762,13.719616,-607246.156669943,512627.764248599,68.8811111450195,11,1.83810014425655,-1.01891175024278 +-163.27918,54.2475295,13.719616,-603542.302972973,512627.790077021,67.7350463867188,11,1.83081343255695,-1.0453791669703 +-163.22296,54.2521548,13.719616,-599838.022309881,512627.750891396,63.2045974731445,11,1.80074866981083,-1.15458296660186 +-163.16673,54.2567521,13.719616,-596133.955815372,512627.737903972,62.0056457519531,11,1.79243123477712,-1.1847942646766 +-163.11049,54.2613215,13.719616,-592430.096912357,512627.761915339,64.3534851074219,11,1.80857207139483,-1.12616613902763 +-163.05424,54.2658629,13.719616,-588726.442080637,512627.811709578,62.546573638916,11,1.79620352361426,-1.17109223490168 +-162.99797,54.2703763,13.719616,-585022.34006964,512627.799002777,60.4000015258789,11,1.78103694959267,-1.22618156071931 +-162.94169,54.2748616,13.719616,-581318.433494753,512627.801800464,56.0884437561035,11,1.74887339013408,-1.34300878906674 +-162.88539,54.279319,13.719616,-577614.068104826,512627.754992806,46.2563819885254,11,1.66517166077642,-1.64703736094586 +-162.82909,54.2837484,13.719616,-573910.532706825,512627.821910827,50.9900398254395,11,1.70748535117049,-1.49334195990495 +-162.77277,54.2881497,13.719616,-570206.531314924,512627.817988595,44.3783493041992,11,1.64717114419139,-1.71242037504164 +-162.71643,54.292523,13.719616,-566502.057368671,512627.75578139,33.0956840515137,11,1.51977136190791,-2.17517274781341 +-162.66009,54.2968683,13.719616,-562798.398164334,512627.806324314,17.8411140441895,11,1.25142196933036,-3.14989433619732 +-162.60373,54.3011854,13.719616,-559094.259116028,512627.777399684,34.2005920410156,11,1.53403362412399,-2.12336814058967 +-162.54736,54.3054746,13.719616,-555390.276988236,512627.787281573,42.0999984741211,11,1.62428208009503,-1.79555998902895 +-162.49098,54.3097356,13.719616,-551686.450974226,512627.802790406,54.685905456543,11,1.73787540729859,-1.3829566018621 +-162.43458,54.3139686,13.719616,-547982.126921217,512627.763382971,45.1567916870117,11,1.6547230784672,-1.68498959421526 +-162.37817,54.3181735,13.719616,-544277.94732237,512627.741583702,49.5355415344238,11,1.69491691516599,-1.53899410686209 +-162.32175,54.3223503,13.719616,-540573.907052634,512627.737327217,50.9842262268066,11,1.70743583252414,-1.49352182576254 +-162.26532,54.326499,13.719616,-536870.000984187,512627.750559176,55.1072273254395,11,1.74120856040754,-1.37084963839377 +-162.20888,54.3306196,13.719616,-533166.223986434,512627.781236347,55.5871734619141,11,1.74497459127003,-1.35717033936898 +-162.15242,54.334712,13.719616,-529461.926099643,512627.73856441,59.3464279174805,11,1.77339458373856,-1.2539408148498 +-162.09596,54.3387763,13.719616,-525758.393183544,512627.793564715,61.1465721130371,11,1.78637211543411,-1.20680271557525 +-162.03948,54.3428125,13.719616,-522054.327723087,512627.787335057,64.7143936157227,11,1.81100088611936,-1.11734399069539 +-161.98299,54.3468206,13.719616,-518350.370764945,512627.799601624,61.3963623046875,11,1.78814264023234,-1.20037166415 +-161.92649,54.3508004,13.719616,-514646.519813408,512627.808292706,68.0045166015625,11,1.83253775785323,-1.0391159253228 +-161.86997,54.3547522,13.719616,-510942.119532749,512627.769617851,135.307098388672,11,2.13132058085605,0.0461485689315948 +-161.81345,54.3586757,13.719616,-507238.461094267,512627.804912524,132.908248901367,11,2.1235519361058,0.0179306338066973 +-161.75691,54.3625711,13.719616,-503534.244321198,512627.782991645,144.11669921875,110,2.15871430668742,0.145650400098929 +-161.70036,54.3664383,13.719616,-499830.111533641,512627.769801865,141.228286743164,110,2.14992169066848,0.113713109055652 +-161.6438,54.3702772,13.719616,-496126.058823389,512627.754360002,143.9443359375,110,2.15819458050632,0.143762606264539 +-161.58723,54.374088,13.719616,-492422.078438521,512627.758836675,139.556198120117,110,2.14474912960708,0.0949248908847426 +-161.53065,54.3778706,13.719616,-488718.166475079,512627.772272396,88.6825485229492,13,1.94783816519967,-0.620311935827795 +-161.47406,54.3816249,13.719616,-485014.318988937,512627.783714376,79.0479431152344,13,1.8978905737581,-0.801735844405521 +-161.41746,54.3853511,13.719616,-481310.528276972,512627.815373943,82.2059478759766,13,1.91490324133889,-0.739940979853331 +-161.36084,54.389049,13.719616,-477606.145441488,512627.773351741,85.5613784790039,110,1.9322777728724,-0.67683172213858 +-161.30422,54.3927186,13.719616,-473902.457629833,512627.802167986,99.0863265991211,110,1.99601372822637,-0.445324540240149 +-161.24758,54.39636,13.719616,-470198.166022968,512627.769743249,105.387054443359,110,2.02278726619807,-0.348075408398371 +-161.19093,54.3999732,13.719616,-466493.91160341,512627.748149386,139.112640380859,110,2.14336659367459,0.0899031257628985 +-161.13428,54.403558,13.719616,-462790.337736256,512627.785122582,160.41259765625,110,2.20523847166484,0.314639446615666 +-161.07761,54.4071147,13.719616,-459086.143228961,512627.774082164,116.919799804688,110,2.06788806306759,-0.184256441119219 +-161.02093,54.410643,13.719616,-455381.972606003,512627.7522837,101.958549499512,110,2.00842364840532,-0.400248168006314 +-160.96425,54.414143,13.719616,-451678.465619448,512627.798995056,102.544967651367,110,2.01091435241898,-0.391201220110999 +-160.90755,54.4176148,13.719616,-447974.3234923,512627.788904558,109.276962280273,110,2.03852861383333,-0.29089834075918 +-160.85084,54.4210582,13.719616,-444270.189483371,512627.768679363,106.147804260254,110,2.0259110149173,-0.336729061443491 +-160.79412,54.4244734,13.719616,-440566.056041913,512627.760676694,103.751258850098,110,2.01599337486205,-0.372752760900438 +-160.73739,54.4278602,13.719616,-436861.920196175,512627.743012217,106.673965454102,111,2.02805843967521,-0.328929001786693 +-160.68066,54.4312187,13.719616,-433158.421733689,512627.792227669,104.540840148926,111,2.01928598601021,-0.360793057405523 +-160.62391,54.4345489,13.719616,-429454.263020614,512627.777583911,117.900764465332,111,2.07151662105776,-0.171076482805364 +-160.56715,54.4378508,13.719616,-425750.084985254,512627.765140181,126.190780639648,111,2.10102762698748,-0.063884085988938 +-160.51039,54.4411243,13.719616,-422046.529642306,512627.807666938,140.094207763672,111,2.14642017962355,0.100994621509726 +-160.45361,54.4443695,13.719616,-418342.298243632,512627.788873304,144.790618896484,111,2.16074042447527,0.153009838215977 +-160.39682,54.4475863,13.719616,-414638.032780557,512627.762108623,153.484436035156,111,2.18606434276598,0.244993537613731 +-160.34003,54.4507747,13.719616,-410934.37414411,512627.789571159,150.688400268555,111,2.17807982236606,0.21599148051221 +-160.28322,54.4539348,13.719616,-407230.023607923,512627.758354153,152.886077880859,111,2.18436793946853,0.238831716635706 +-160.22641,54.4570665,13.719616,-403526.269316529,512627.780927411,138.086349487305,111,2.1401507485616,0.078222258418934 +-160.16959,54.4601698,13.719616,-399822.459778176,512627.795769292,132.883010864258,111,2.12346945980245,0.0176310563318622 +-160.11275,54.4632448,13.719616,-396117.942476606,512627.754676719,127.832473754883,111,2.1066411932673,-0.0434940109892952 +-160.05591,54.4662913,13.719616,-392414.00653446,512627.755728104,119.189292907715,111,2.07623724332408,-0.153929835334364 +-159.99906,54.4693095,13.719616,-388709.998418377,512627.761262908,110.417686462402,111,2.04303864330096,-0.274516626442152 +-159.9422,54.4722992,13.719616,-385005.914832653,512627.749528549,118.16584777832,111,2.07249197515269,-0.167533718338808 +-159.88534,54.4752605,13.719616,-381302.395638442,512627.789431396,129.67692565918,111,2.112862705842,-0.020895701521499 +-159.82846,54.4781934,13.719616,-377598.14314334,512627.766008419,130.585693359375,111,2.11589559933245,-0.00987936669017075 +-159.77158,54.4810979,13.719616,-373894.444405487,512627.793970133,128.521713256836,111,2.10897650627437,-0.0350114875829259 +-159.71468,54.483974,13.719616,-370190.001728466,512627.76060779,125.693855285645,111,2.09931404713094,-0.0701082971322646 +-159.65778,54.4868216,13.719616,-366486.10311294,512627.767341139,124.999069213867,111,2.09690677911377,-0.078852181673338 +-159.60087,54.4896408,13.719616,-362782.096081193,512627.769424119,118.398139953613,111,2.0733448796316,-0.164435725828214 +-159.54395,54.4924315,13.719616,-359077.976234712,512627.756255965,116.319923400879,111,2.06565410752299,-0.192370805291617 +-159.48703,54.4951938,13.719616,-355374.383487169,512627.792927115,119.76375579834,111,2.07832540704874,-0.146345028665126 +-159.43009,54.4979276,13.719616,-351670.021040938,512627.761278292,120.86531829834,111,2.08230170009617,-0.131901997369834 +-159.37315,54.5006329,13.719616,-347966.175912044,512627.768291301,127.815223693848,111,2.10658258443642,-0.0437068949916516 +-159.3162,54.5033098,13.719616,-344262.195660696,512627.772071806,137.118988037109,111,2.13709759941926,0.067132349278409 +-159.25924,54.5059582,13.719616,-340558.07583143,512627.762073752,146.97966003418,111,2.16725723851614,0.176680766896323 +-159.20228,54.5085782,13.719616,-336854.456376055,512627.800661946,144.005661010742,111,2.15837956499388,0.144434522723184 +-159.1453,54.5111696,13.719616,-333150.041301155,512627.76421872,149.504211425781,111,2.17465342659501,0.203545833081035 +-159.08832,54.5137325,13.719616,-329446.116733549,512627.76529665,176.363815307617,111,2.24640948542034,0.464184319952916 +-159.03133,54.516267,13.719616,-325742.030271908,512627.764853147,197.298934936523,210,2.29512474084044,0.641132032356921 +-158.97434,54.5187729,13.719616,-322038.424424812,512627.789796036,240.413909912109,221,2.38095959154746,0.952908709830375 +-158.91733,54.5212504,13.719616,-318333.999766845,512627.765380943,274.882263183594,221,2.43914671783545,1.16426096076767 +-158.86032,54.5236993,13.719616,-314630.044953198,512627.766470277,312.494110107422,320,2.49484183616985,1.36656152752767 +-158.8033,54.5261197,13.719616,-310925.907585118,512627.756300687,332.260650634766,320,2.52147891117315,1.4633149869178 +-158.74628,54.5285116,13.719616,-307222.228470898,512627.781780074,367.194061279297,320,2.56489564863354,1.62101696974458 +-158.68925,54.5308749,13.719616,-303518.356825709,512627.785094797,553.336853027344,320,2.74298959581225,2.26790501897101 +-166.17194,53.9359564,13.71893396,-796150.052867069,508923.75068353,64.1389236450195,10,1.80712166748904,-1.13143441999996 +-166.11656,53.9420171,12.94656122,-792445.889166323,508923.71528655,48.9494743347168,10,1.68974803230345,-1.55776896476487 +-166.06117,53.9480505,13.66084189,-788742.179124939,508923.774367775,60.1310539245605,10,1.77909881584633,-1.23322141568447 +-166.00576,53.9540564,13.719616,-785038.275307297,508923.787140991,99.9376373291016,10,1.9997290778756,-0.431829329847761 +-165.95033,53.9600349,13.719616,-781334.170979791,508923.76550108,126.833343505859,10,2.10323344121903,-0.0558719390978613 +-165.89489,53.965986,13.719616,-777630.508167419,508923.82751707,109.59204864502,10,2.03977904543611,-0.286356416269165 +-165.83942,53.9719097,13.719616,-773925.98865389,508923.739429532,61.8141059875488,10,1.79108759245947,-1.18967475708799 +-165.78394,53.9778059,13.719616,-770221.903164528,508923.724923106,87.6684341430664,10,1.94284324963522,-0.638454894848709 +-165.72845,53.9836746,13.719616,-766518.246940127,508923.783324248,74.1704177856445,10,1.87023072530395,-0.902204308897755 +-165.67294,53.9895158,13.719616,-762814.368471944,508923.799106837,76.2815704345703,10,1.88241962543385,-0.857930744567501 +-165.61741,53.9953296,13.719616,-759110.261059085,508923.784235308,73.353889465332,10,1.86542314651669,-0.919666807272665 +-165.56186,54.0011159,13.719616,-755405.921884096,508923.728797554,69.4739761352539,10,1.84182215513151,-1.00539234437725 +-165.5063,54.0068746,13.719616,-751701.994835266,508923.736073793,66.8833847045898,10,1.82531824291976,-1.06533926421585 +-165.45073,54.0126059,13.719616,-747998.471293908,508923.827335173,72.9359970092773,10,1.86294192398341,-0.928679315724967 +-165.39513,54.0183095,13.719616,-744294.058708308,508923.744969704,70.9835357666016,10,1.85115762822769,-0.971483241482637 +-165.33952,54.0239857,13.719616,-740590.040064845,508923.747602374,59.144474029541,10,1.77191417397515,-1.25931808566153 +-165.2839,54.0296343,13.29560561,-736886.414362022,508923.812733879,51.7666358947754,10,1.71404994284921,-1.46949748920684 +-165.22826,54.0352553,13.719616,-733182.530034958,508923.8293746,64.3645172119141,10,1.8086465160262,-1.12589573487789 +-165.1726,54.0408488,13.719616,-729478.380399929,508923.809577298,68.1874237060547,10,1.83370428200673,-1.03487877663814 +-165.11692,54.0464146,13.719616,-725773.964362424,508923.732530974,58.2854347229004,10,1.76556004001153,-1.2823981138678 +-165.06123,54.0519529,13.20532697,-722069.920125556,508923.729996179,61.6577224731445,10,1.78998747861927,-1.19367068455938 +-165.00553,54.0574635,13.12441632,-718366.246551142,508923.779502249,57.6098136901855,10,1.76049647072288,-1.30079044281075 +-164.94981,54.0629466,13.12155474,-714662.288380273,508923.794824054,54.2534141540527,11,1.73442707342582,-1.39548193474046 +-164.89407,54.0684019,13.719616,-710958.046246415,508923.744211126,67.061653137207,11,1.82647425502059,-1.06114029830694 +-164.83832,54.0738297,13.719616,-707254.156578576,508923.768210266,75.2225646972656,11,1.87634813651635,-0.879984125291327 +-164.78255,54.0792298,13.719616,-703549.971405416,508923.738439678,97.9572372436523,11,1.99103652791494,-0.463403152405652 +-164.72677,54.0846022,13.719616,-699846.132594963,508923.761450923,97.4431304931641,11,1.98875122781413,-0.471704014661401 +-164.67097,54.089947,13.719616,-696141.986741558,508923.742901555,92.2671432495117,11,1.96504707431035,-0.557804266026137 +-164.61516,54.095264,13.719616,-692438.179272626,508923.766303441,91.5526428222656,11,1.96167088546525,-0.570067547571778 +-164.55933,54.1005534,13.719616,-688734.055006426,508923.749424925,88.9105606079102,11,1.94895334861192,-0.616261271369457 +-164.50349,54.1058151,13.719616,-685030.257575936,508923.785654523,82.232307434082,11,1.91504247670972,-0.739435237244731 +-164.44763,54.111049,13.719616,-681326.137082158,508923.760969282,82.3425903320312,11,1.91562452490597,-0.737321072062844 +-164.39176,54.1162553,13.719616,-677622.331880333,508923.800593451,80.3406829833984,11,1.90493551938794,-0.776146591050265 +-164.33587,54.1214337,13.719616,-673918.195520448,508923.769676619,77.0497665405273,11,1.88677132715159,-0.842124121829315 +-164.27997,54.1265845,13.719616,-670214.364646338,508923.803334001,83.9435424804688,11,1.92398729281515,-0.706945112045102 +-164.22405,54.1317075,13.719616,-666510.191041277,508923.778827806,76.2049713134766,11,1.8819833039326,-0.859515588798589 +-164.16812,54.1368027,13.719616,-662806.316512127,508923.79723087,71.3000030517578,11,1.85308954844039,-0.964465955845183 +-164.11217,54.1418701,13.719616,-659102.089370723,508923.758903835,72.2970352172852,11,1.85912048795603,-0.942559862122853 +-164.05621,54.1469097,13.719616,-655398.151417387,508923.763824982,72.8798446655273,11,1.86260743832037,-0.929894263124834 +-164.00024,54.1519216,13.719616,-651694.49603556,508923.822613449,70.9455871582031,11,1.85092538735595,-0.972326806616911 +-163.94425,54.1569056,13.719616,-647990.474872132,508923.815352599,78.6840744018555,11,1.89588684037323,-0.80901397598181 +-163.88824,54.1618618,13.719616,-644286.081294845,508923.754354302,91.8026351928711,11,1.96285514779489,-0.565765968768389 +-163.83222,54.1667902,13.719616,-640581.957091152,508923.737407911,88.2806930541992,11,1.94586573396439,-0.627476369062255 +-163.77619,54.1716908,13.719616,-636878.097299446,508923.764182911,83.1304779052734,11,1.91976027720617,-0.722298839247297 +-163.72015,54.1765635,13.719616,-633174.49857642,508923.823360275,78.252311706543,11,1.89349717620655,-0.817693918313264 +-163.66409,54.1814083,13.719616,-629470.509180468,508923.819842327,82.8106918334961,11,1.91808641292639,-0.728378792079901 +-163.60801,54.1862253,13.719616,-625766.12250981,508923.766001129,89.3759536743164,11,1.9512206889158,-0.608025644222402 +-163.55192,54.1910144,13.719616,-622061.98192977,508923.745886822,91.1519012451172,11,1.95976573159387,-0.576987610217674 +-163.49582,54.1957756,13.719616,-618358.082435246,508923.75921756,86.6826934814453,11,1.93793239764034,-0.656292510990849 +-163.43971,54.2005089,13.719616,-614654.419018015,508923.805722187,74.4480361938477,11,1.87185324632696,-0.89631084942857 +-163.38358,54.2052143,13.719616,-610950.339920913,508923.793144964,71.2877502441406,11,1.85301490911652,-0.964737067173662 +-163.32744,54.2098918,13.719616,-607246.486875456,508923.81434684,70.2625350952148,11,1.84672381522545,-0.987588115842998 +-163.27128,54.2145414,13.719616,-603542.208118363,508923.778208951,71.8806076049805,11,1.85661173953286,-0.951672352463897 +-163.21511,54.219163,13.719616,-599838.146912946,508923.765486369,71.7729873657227,11,1.85596102299765,-0.954035940652766 +-163.15893,54.2237567,13.719616,-596134.296679273,508923.786970581,68.1000366210938,11,1.83314734545661,-1.03690172915367 +-163.10273,54.2283225,13.719616,-592430.005645011,508923.753248197,67.5808639526367,11,1.82982373948777,-1.04897401468409 +-163.04652,54.2328602,13.719616,-588725.9185465,508923.732413217,64.8210983276367,11,1.81171638543718,-1.11474509294925 +-162.9903,54.23737,13.719616,-585022.027294184,508923.746306907,62.8247146606445,11,1.79813052477613,-1.16409281666087 +-162.93407,54.2418519,13.719616,-581318.3268527,508923.794754814,60.2141189575195,11,1.77969833621458,-1.23104378658682 +-162.87782,54.2463057,13.719616,-577614.168401872,508923.768577626,58.9695358276367,11,1.77062770928892,-1.26399089259549 +-162.82156,54.2507316,13.719616,-573910.19064508,508923.777748355,60.5224456787109,11,1.78191646930667,-1.22298689407814 +-162.76529,54.2551294,13.719616,-570206.391464894,508923.80007969,60.495792388916,11,1.78172516959756,-1.223681749224 +-162.709,54.2594992,13.719616,-566502.117558449,508923.761154232,60.4771003723145,11,1.781590960362,-1.22416923547467 +-162.6527,54.263841,13.719616,-562798.010593749,508923.74726575,46.9765434265137,11,1.67188105786477,-1.62266691566838 +-162.59639,54.2681548,13.719616,-559094.065490055,508923.758301038,42.4782180786133,11,1.62816629020955,-1.78145142922908 +-162.54007,54.2724405,13.719616,-555390.278589781,508923.783129949,57.9740905761719,11,1.76323394470376,-1.29084715595931 +-162.48373,54.2766982,13.719616,-551685.996615969,508923.749615043,58.9088401794434,11,1.77018047225855,-1.26561538514397 +-162.42739,54.2809278,13.719616,-547982.50937844,508923.813346171,65.3184051513672,11,1.81503557223094,-1.10268885912406 +-162.37103,54.2851294,13.719616,-544278.516867431,508923.819696714,63.8050231933594,11,1.80485487087291,-1.1396680723179 +-162.31465,54.2893028,13.719616,-540574.016765326,508923.748215581,59.5076599121094,11,1.77457287234108,-1.24966093432841 +-162.25827,54.2934482,13.719616,-536870.294651715,508923.784270548,55.8382720947266,11,1.74693197065851,-1.35006057873831 +-162.20187,54.2975655,13.719616,-533166.053304402,508923.754551133,61.1564292907715,11,1.78644212055021,-1.20654843701212 +-162.14546,54.3016547,13.719616,-529461.934338141,508923.740426566,62.9370155334473,11,1.79890614486754,-1.16127554310486 +-162.08904,54.3057158,13.719616,-525757.932619088,508923.741878929,60.6906356811523,11,1.78312168636789,-1.21860920170858 +-162.03261,54.3097488,13.719616,-522054.043010697,508923.758901402,65.3385391235352,11,1.8151694200433,-1.1022026856656 +-161.97617,54.3137536,13.719616,-518350.261706122,508923.780457925,64.343994140625,11,1.80850801614621,-1.12639880597382 +-161.91971,54.3177303,13.719616,-514645.93546644,508923.740107801,65.2789535522461,11,1.81477318388723,-1.10364192848152 +-161.86325,54.3216789,13.719616,-510942.352638845,508923.793423414,69.2947692871094,11,1.84070045314743,-1.00946668614905 +-161.80677,54.3255993,13.719616,-507238.215888636,508923.774968179,74.1959228515625,11,1.87038004097016,-0.901661951779137 +-161.75028,54.3294916,13.719616,-503534.165488859,508923.773326577,129.054748535156,11,2.11077398892386,-0.0284825175473289 +-161.69378,54.3333557,13.719616,-499830.197572577,508923.777512376,140.354064941406,110,2.14722499521098,0.103917941440498 +-161.63727,54.3371916,13.719616,-496126.306956622,508923.787593304,140.987823486328,110,2.14918160612312,0.111024910745733 +-161.58075,54.3409993,13.719616,-492422.488455243,508923.803648354,147.898880004883,110,2.1699648852238,0.186515712577854 +-161.52421,54.3447789,13.719616,-488718.088876973,508923.763227548,109.708740234375,110,2.04024122816134,-0.284677636691048 +-161.46767,54.3485302,13.719616,-485014.399046691,508923.792071614,90.5544586181641,110,1.95690983847774,-0.587361029168504 +-161.41111,54.3522534,13.719616,-481310.1177741,508923.765771811,92.5365142822266,110,1.96631313622173,-0.553205567793926 +-161.35454,54.3559483,13.719616,-477605.889095571,508923.735939226,93.1839294433594,111,1.96934102012364,-0.542207429218079 +-161.29797,54.3596151,13.719616,-473902.352091069,508923.796173161,99.8716888427734,111,1.99944239391254,-0.432870647829366 +-161.24138,54.3632536,13.719616,-470198.210516747,508923.781237364,108.287788391113,111,2.03457948401796,-0.305242707442475 +-161.18478,54.3668638,13.719616,-466494.105886958,508923.763203162,145.517578125,111,2.16291545807507,0.160910181066862 +-161.12817,54.3704458,13.719616,-462790.031776313,508923.753294046,150.324310302734,111,2.17702921995207,0.212175392672819 +-161.07155,54.3739996,13.719616,-459085.982976665,508923.751690669,122.435249328613,111,2.08790646997466,-0.111543873410544 +-161.01492,54.3775251,13.719616,-455381.955450059,508923.747525409,106.117614746094,111,2.02578747958534,-0.337177777029636 +-160.95828,54.3810224,13.719616,-451677.942792151,508923.752059101,107.150047302246,111,2.02999236710067,-0.321904425379598 +-160.90163,54.3844913,13.719616,-447973.942095105,508923.743383045,104.81037902832,111,2.02040429153641,-0.356731052538219 +-160.84497,54.387932,13.719616,-444269.945796123,508923.743842666,105.18383026123,111,2.02194898156613,-0.351120297451819 +-160.7883,54.3913445,13.719616,-440565.948675246,508923.753675526,106.011329650879,111,2.025352281698,-0.338758539974311 +-160.73162,54.3947286,13.719616,-436861.947761051,508923.751000947,110.475250244141,111,2.04326499398202,-0.27369445616163 +-160.67493,54.3980844,13.719616,-433157.936656367,508923.747139056,103.801528930664,111,2.01620375044173,-0.371988616747874 +-160.61823,54.4014119,13.719616,-429453.910106037,508923.742358682,110.248085021973,111,2.04237105463318,-0.276941499032315 +-160.56153,54.4047111,13.719616,-425750.509598509,508923.801048487,110.426414489746,111,2.04307297099275,-0.274391938467482 +-160.50481,54.407982,13.719616,-422046.436382363,508923.79472585,124.979957580566,111,2.09684037292757,-0.0790933878958053 +-160.44808,54.4112246,13.719616,-418342.331941577,508923.788360188,129.5849609375,111,2.11255460214535,-0.0220148220892801 +-160.39134,54.4144388,13.719616,-414638.192080795,508923.771195499,138.04606628418,111,2.14002403563725,0.0777620009102364 +-160.33459,54.4176247,13.719616,-410934.010446057,508923.754627035,146.359252929688,111,2.16542018402486,0.170008060636438 +-160.27784,54.4207823,13.719616,-407230.428514779,508923.800312328,152.406021118164,111,2.18300212505305,0.233870688836415 +-160.22107,54.4239115,13.719616,-403526.148564949,508923.774330127,145.181198120117,111,2.16191037613401,0.157259436577984 +-160.1643,54.4270123,13.719616,-399822.458787175,508923.799120192,140.366439819336,111,2.14726328483437,0.104057020281597 +-160.10751,54.4300848,13.719616,-396118.059364986,508923.765161761,132.633544921875,111,2.12265337725153,0.0146668115737549 +-160.05072,54.4331289,13.719616,-392414.23952513,508923.781613162,125.414665222168,111,2.09834832319862,-0.073616082099511 +-159.99392,54.4361446,13.719616,-388710.347214256,508923.788663265,124.118270874023,111,2.09383571667767,-0.0900071570097264 +-159.93711,54.4391319,13.719616,-385006.377122828,508923.786716735,145.044021606445,111,2.16149983285024,0.155768226190583 +-159.88029,54.4420909,13.719616,-381302.322955684,508923.787269072,144.583648681641,111,2.16011918031072,0.150753302089583 +-159.82346,54.4450214,13.719616,-377598.181375802,508923.768590769,142.475357055664,111,2.15373975402706,0.127581404957797 +-159.76662,54.4479236,13.719616,-373893.94510988,508923.753280744,143.104553222656,111,2.15565345212467,0.134532502672117 +-159.70978,54.4507973,13.719616,-370190.257524865,508923.775371516,137.987518310547,111,2.13983980398085,0.077092818949223 +-159.65293,54.4536427,13.719616,-366486.464635518,508923.800631137,140.784942626953,111,2.1485562081888,0.108753286941966 +-159.59606,54.4564596,13.719616,-362781.916275164,508923.752743022,144.271713256836,111,2.1591811891621,0.14734625050847 +-159.53919,54.4592481,13.719616,-359077.899656913,508923.753086695,150.451400756836,111,2.17739623553328,0.21350849802044 +-159.48232,54.4620081,13.719616,-355374.410372506,508923.789401838,161.057846069336,111,2.20698188669446,0.320972027623437 +-159.42543,54.4647397,13.719616,-351670.148666685,508923.765701553,179.558319091797,111,2.25420553116616,0.492501783314714 +-159.36854,54.4674429,13.719616,-347966.402701974,508923.788972303,192.695877075195,111,2.28487242258152,0.60389268613756 +-159.31164,54.4701177,13.719616,-344262.520401406,508923.806236143,193.822326660156,111,2.28740380257448,0.613087380799777 +-159.25473,54.4727639,13.719616,-340558.498190456,508923.795861139,192.65119934082,111,2.28477171703695,0.603526894855449 +-159.19781,54.4753817,13.719616,-336854.328937955,508923.78057798,190.677383422852,111,2.28029918367448,0.587281377094867 +-159.14088,54.4779711,13.719616,-333150.00730732,508923.760955351,189.022659301758,210,2.27651386882856,0.573532033138052 +-159.08395,54.480532,13.719616,-329446.175556763,508923.776089936,222.940185546875,210,2.34818835824358,0.83387423662944 +-159.02701,54.4830644,13.719616,-325742.181571758,508923.775849048,302.015258789062,310,2.48002888547531,1.31275666256803 +-158.97006,54.4855683,13.719616,-322038.019981894,508923.760834455,336.655914306641,320,2.52718624847328,1.48404566502814 +-158.91311,54.4880438,13.719616,-318334.331338721,508923.79068679,408.945465087891,320,2.61166539653904,1.79089804355246 +-158.85615,54.4904907,13.719616,-314630.465176352,508923.79479659,474.696075439453,320,2.67641564119374,2.02608941369815 +-158.79918,54.4929092,13.719616,-310926.414484376,508923.795988168,470.204193115234,320,2.67228649769128,2.0110911859223 +-158.7422,54.4952991,13.719616,-307222.175501351,508923.772722204,650.167785644531,320,2.81302544737572,2.52229522207177 +-166.217,53.8971009,10.70799391,-799853.984255368,505219.732929742,15.0494518280029,10,1.17752068116513,-3.41832490834111 +-166.16169,53.9031843,13.719616,-796150.360955906,505219.802868921,81.0656280517578,10,1.90883675172462,-0.761976201680869 +-166.10635,53.9092403,13.719616,-792445.901487029,505219.714068138,234.6337890625,10,2.3703905540145,0.91451894880701 +-166.051,53.915269,13.719616,-788741.893742244,505219.717615203,191.347579956055,10,2.28182297391156,0.592816218168976 +-165.99564,53.9212703,13.719616,-785038.335033384,505219.801870149,114.231773376465,10,2.05778691899571,-0.220946679541856 +-165.94025,53.9272441,13.719616,-781333.92802498,505219.719893191,89.4629287719727,10,1.95164311168468,-0.606491284154371 +-165.88485,53.9331906,13.719616,-777629.958621206,505219.73039088,76.7504577636719,10,1.88508097442471,-0.848263965408037 +-165.82944,53.9391096,13.719616,-773926.426064721,505219.81080948,80.0518341064453,10,1.90337128670108,-0.781828330645392 +-165.774,53.9450012,13.719616,-770222.029034351,505219.73945331,69.3379592895508,10,1.84097105563118,-1.00848378069045 +-165.71855,53.9508654,13.719616,-766518.057407097,505219.749845337,102.805076599121,10,2.012014561007,-0.387204948488509 +-165.66309,53.9567021,13.719616,-762814.508390907,505219.830388448,91.3424377441406,10,1.96067259786329,-0.57369361308174 +-165.6076,53.9625113,13.719616,-759110.082613725,505219.751823501,92.1674270629883,10,1.96457746393622,-0.559510024945112 +-165.5521,53.9682931,13.719616,-755406.06799079,505219.755297812,81.6069793701172,10,1.91172730302236,-0.75147689432202 +-165.49659,53.9740473,13.719616,-751702.463606282,505219.818290648,86.2013244628906,10,1.93551393870761,-0.665077044131403 +-165.44105,53.9797741,13.719616,-747997.966239395,505219.736813484,76.2285690307617,10,1.88211776723327,-0.859027179710881 +-165.38551,53.9854733,13.719616,-744294.516841468,505219.82792661,86.7709426879883,10,1.93837431569507,-0.654687338480099 +-165.32994,53.991145,13.719616,-740590.166804488,505219.765756709,80.4794464111328,10,1.9056849803682,-0.773424334852501 +-165.27436,53.9967892,13.719616,-736886.205949403,505219.774977081,76.2337265014648,10,1.88214714972499,-0.858920454114368 +-165.21876,54.0024058,13.719616,-733181.984051462,505219.733650716,71.6503448486328,10,1.8552182849706,-0.956733777165555 +-165.16315,54.0079949,13.719616,-729478.141733965,505219.763677029,75.8642425537109,10,1.8800371260829,-0.866584662243159 +-165.10752,54.0135564,13.719616,-725774.028746837,505219.744251242,74.9866409301758,10,1.874983899564,-0.884939423294254 +-165.05188,54.0190903,13.719616,-722070.287565896,505219.785219265,71.9913177490234,10,1.8572801230833,-0.949244592633023 +-164.99622,54.0245967,13.719616,-718366.264224216,505219.788829942,74.4294738769531,11,1.87174494908533,-0.896704215921266 +-164.94054,54.0300754,13.719616,-714661.957560275,505219.734297406,75.4337692260742,11,1.87756580880553,-0.875561191978747 +-164.88485,54.0355265,13.719616,-710958.00819829,505219.74078619,78.9119415283203,11,1.89714272877891,-0.804452230826134 +-164.82915,54.04095,13.719616,-707254.411296617,505219.807782109,85.3146438598633,11,1.93102358218383,-0.681387300701146 +-164.77343,54.0463459,13.719616,-703550.514706583,505219.828842416,103.613578796387,11,2.01541667442373,-0.374847501499098 +-164.71769,54.0517141,13.719616,-699846.315365834,505219.794175272,99.0182037353516,11,1.99571504363856,-0.446409447916129 +-164.66194,54.0570547,13.719616,-696142.453921625,505219.820761527,97.6934356689453,11,1.98986538307874,-0.467657084728749 +-164.60617,54.0623676,13.719616,-692438.279982824,505219.792887854,94.4003982543945,11,1.97497382649427,-0.521747468716975 +-164.55039,54.0676528,13.719616,-688734.435966837,505219.815467346,98.5223999023438,11,1.99353498225406,-0.454328053116106 +-164.49459,54.0729103,13.719616,-685030.269680484,505219.784892324,92.9725570678711,11,1.96835477572817,-0.545789750364631 +-164.43878,54.0781401,13.719616,-681326.423534461,505219.804981,87.9050140380859,11,1.94401364762176,-0.634203675296761 +-164.38295,54.0833423,13.719616,-677622.243598018,505219.784242446,86.5300369262695,11,1.93716688904812,-0.659073056695695 +-164.32711,54.0885167,13.719616,-673918.375746192,505219.803440283,88.896110534668,11,1.94888275972968,-0.61651767033785 +-164.27125,54.0936634,13.719616,-670214.166032407,505219.772218204,84.4659652709961,11,1.92668174951126,-0.697158076250348 +-164.21538,54.0987823,13.719616,-666510.258557343,505219.781219538,74.1258773803711,11,1.86996984686741,-0.903151893841379 +-164.15949,54.1038735,13.719616,-662805.999386296,505219.741227338,68.3074111938477,11,1.83446782617024,-1.03210536629907 +-164.10359,54.108937,13.719616,-659102.030910209,505219.752775513,68.9408950805664,11,1.83847691768561,-1.01754320160658 +-164.04768,54.1139726,13.719616,-655398.351564198,505219.793509671,71.2166366577148,11,1.8525814594325,-0.966311480144865 +-163.99175,54.1189805,13.719616,-651694.305737528,505219.786908737,63.6033897399902,11,1.80348026197142,-1.14466104420056 +-163.9358,54.1239606,13.719616,-647989.890164875,505219.723299281,75.4663619995117,11,1.8777534144989,-0.874879754552439 +-163.87985,54.128913,13.719616,-644286.392852416,505219.809030739,86.2060165405273,11,1.93553757741597,-0.664991181595471 +-163.82388,54.1338375,13.719616,-640582.517541247,505219.82719116,78.2120742797852,11,1.8932738040611,-0.818505269702296 +-163.76789,54.1387341,13.719616,-636878.259243968,505219.77912248,79.4297561645508,11,1.89998322934339,-0.794134722016376 +-163.71189,54.143603,13.719616,-633174.257033603,505219.783516362,78.9849853515625,11,1.8975445419397,-0.802992730737261 +-163.65588,54.148444,13.719616,-629470.509193466,505219.818071181,82.8863296508789,11,1.91848290875594,-0.726938606055775 +-163.59985,54.1532572,13.719616,-625766.36182161,505219.799262814,81.6874313354492,11,1.91215523986695,-0.7499225055571 +-163.54381,54.1580425,13.719616,-622062.458841661,505219.811145404,80.3374176025391,11,1.90491786748785,-0.776210707789729 +-163.48775,54.1628,13.719616,-618358.146363988,505219.771334409,80.1143569946289,11,1.90371035135041,-0.780596751060344 +-163.43168,54.1675295,13.719616,-614654.069861135,505219.751781032,73.7832107543945,11,1.86795755008537,-0.910461130120449 +-163.3756,54.1722312,13.719616,-610950.221167277,505219.774238624,78.1382446289062,11,1.89286365059823,-0.819995064148899 +-163.3195,54.176905,13.719616,-607245.949549401,505219.73601901,74.5815124511719,11,1.87263118624623,-0.893485149595617 +-163.26339,54.1815509,13.719616,-603541.897295762,505219.729439629,75.9722671508789,11,1.88065508673632,-0.864340052766389 +-163.20727,54.1861689,13.719616,-599838.059387971,505219.754275652,80.7120971679688,11,1.90693863186655,-0.768870714782719 +-163.15114,54.190759,13.719616,-596134.430804632,505219.810312972,76.4577560424805,11,1.8834215477679,-0.8542914766731 +-163.09499,54.1953211,13.719616,-592430.360735633,505219.79712746,70.7223052978516,11,1.84955640870494,-0.977299327822812 +-163.03883,54.1998553,13.719616,-588726.489920722,505219.815860026,68.2659225463867,11,1.83420396366187,-1.03306379024331 +-162.98265,54.2043615,13.719616,-585022.16752524,505219.767220821,68.0749740600586,11,1.8329874845243,-1.0374823896887 +-162.92646,54.2088398,13.719616,-581318.034301615,505219.751259613,63.6248550415039,11,1.80362680587925,-1.14412875489953 +-162.87026,54.2132901,13.719616,-577614.086694308,505219.756796553,64.6074295043945,11,1.81028246237952,-1.11995351077706 +-162.81405,54.2177125,13.719616,-573910.318164906,505219.794699165,62.2000007629395,11,1.79379039001783,-1.1798574249008 +-162.75782,54.2221068,13.719616,-570206.079291825,505219.756924229,64.1643905639648,11,1.80729407367484,-1.1308081915235 +-162.70158,54.2264732,13.719616,-566502.009372459,505219.752358851,67.8834533691406,11,1.83176392764995,-1.04192669749423 +-162.64533,54.2308115,13.719616,-562798.106245784,505219.758836428,70.8519592285156,11,1.85035186404528,-0.974410006981135 +-162.58907,54.2351219,13.719616,-559094.361937147,505219.798295507,67.6999969482422,11,1.83058864910816,-1.04619564461589 +-162.53279,54.2394042,13.719616,-555390.126938905,505219.764956923,66.5486221313477,11,1.82313906797076,-1.07325464962907 +-162.4765,54.2436585,13.719616,-551686.042027042,505219.754502166,68.1935119628906,11,1.83374305716745,-1.03473793418686 +-162.4202,54.2478848,13.719616,-547982.102114498,505219.766854157,67.2781524658203,11,1.82787405673581,-1.05605581893409 +-162.36389,54.252083,13.719616,-544278.303508102,505219.790915506,71.0403137207031,11,1.85150487066003,-0.970221957855491 +-162.30756,54.2562531,13.719616,-540573.993783579,505219.745229063,68.81591796875,11,1.83768890751442,-1.02040547946886 +-162.25123,54.2603952,13.719616,-536870.461046739,505219.804134889,66.8800048828125,11,1.82529629613817,-1.06541898119082 +-162.19488,54.2645093,13.719616,-533166.405592227,505219.805361152,64.8635330200195,11,1.8120006003547,-1.11371274324581 +-162.13852,54.2685952,13.719616,-529462.472341366,505219.808211446,66.0032119750977,11,1.81956507052852,-1.08623642845975 +-162.08214,54.2726531,13.719616,-525758.006131012,505219.755574993,62.5335960388184,11,1.79611340381117,-1.17141957574926 +-162.02576,54.2766828,13.719616,-522054.299143258,505219.784266666,67.338752746582,11,1.82826506809167,-1.05463555408385 +-161.96936,54.2806845,13.719616,-518350.048943396,505219.758593221,66.2431564331055,11,1.82114101805249,-1.08051213723245 +-161.91295,54.284658,13.719616,-514645.900367112,505219.735661871,66.2530517578125,11,1.82120588760587,-1.08027651249897 +-161.85654,54.2886035,13.719616,-510942.492922697,505219.814519502,69.5415649414062,11,1.84224445968302,-1.00385841370847 +-161.80011,54.2925208,13.719616,-507238.529492237,505219.818693133,73.390983581543,11,1.86564270812713,-0.918869296834443 +-161.74366,54.2964099,13.719616,-503534.004900051,505219.749904311,75.2462463378906,11,1.87648484000805,-0.879487579190385 +-161.68721,54.3002709,13.719616,-499830.207290747,505219.771457837,137.626937866211,111,2.13870344713822,0.0729652465482728 +-161.63075,54.3041038,13.719616,-496126.484207974,505219.807049363,137.527709960938,111,2.13839021140756,0.071827484968114 +-161.57427,54.3079085,13.719616,-492422.184458367,505219.771568522,136.77880859375,111,2.13601881650906,0.0632139018332923 +-161.51778,54.3116851,13.719616,-488717.948903378,505219.751420867,114.865875244141,111,2.06019102612636,-0.21221427624285 +-161.46129,54.3154334,13.719616,-485014.422179785,505219.797645582,110.021789550781,111,2.041478704654,-0.280182768858742 +-161.40478,54.3191536,13.719616,-481310.301986381,505219.785835906,106.810050964355,111,2.02861212228965,-0.326917868494312 +-161.34826,54.3228456,13.719616,-477606.231689381,505219.778659409,107.995399475098,111,2.03340525525422,-0.30950784147062 +-161.29173,54.3265094,13.719616,-473902.206092741,505219.776254269,106.150016784668,111,2.0259200671736,-0.336696181064833 +-161.23519,54.330145,13.719616,-470198.219997954,505219.778769976,112.206832885742,111,2.05001930428394,-0.249160873272963 +-161.17864,54.3337524,13.719616,-466494.268204072,505219.786367308,135.245330810547,111,2.13112228052006,0.0454282855107362 +-161.12208,54.3373315,13.719616,-462790.346698049,505219.788161376,139.201248168945,111,2.14364312945885,0.0909075826624842 +-161.06551,54.3408825,13.719616,-459086.447883992,505219.806448503,125.490089416504,111,2.09860942875189,-0.0726676722030954 +-161.00892,54.3444052,13.719616,-455381.921621371,505219.750738175,123.176155090332,111,2.09052664358348,-0.102026654991312 +-160.95233,54.3478996,13.719616,-451678.057278603,505219.758931509,116.279907226562,111,2.06550467659849,-0.192913581061212 +-160.89573,54.3513658,13.719616,-447974.201158203,505219.773176131,113.378929138184,111,2.05453235077125,-0.232768200279347 +-160.83912,54.3548038,13.719616,-444270.348044903,505219.793700897,101.813323974609,111,2.0078046164094,-0.402496668904833 +-160.7825,54.3582135,13.719616,-440566.49385494,505219.809682754,96.675910949707,111,1.98531827299819,-0.484173486415741 +-160.72586,54.3615949,13.719616,-436861.986036523,505219.755588703,105.897979736328,111,2.02488767495419,-0.340446124279789 +-160.66922,54.364948,13.719616,-433158.113946406,505219.763799584,114.560150146484,111,2.05903357416548,-0.216418472134432 +-160.61257,54.3682729,13.719616,-429454.223922684,505219.77931397,110.286689758301,111,2.04252310162124,-0.276389220973151 +-160.55591,54.3715695,13.719616,-425750.311834748,505219.791350414,112.698638916016,111,2.05191867101653,-0.242261831166965 +-160.49924,54.3748377,13.719616,-422046.373512007,505219.78913497,125.995971679688,111,2.10035666015526,-0.0663212290365343 +-160.44256,54.3780777,13.719616,-418342.401512226,505219.795109238,130.661148071289,111,2.1161464698559,-0.00896813334343988 +-160.38587,54.3812894,13.719616,-414638.391669826,505219.798523213,138.49641418457,111,2.14143852921264,0.0828998453126998 +-160.32917,54.3844727,13.719616,-410934.339779267,505219.788634537,150.40901184082,111,2.17727385803414,0.213063988013565 +-160.27246,54.3876277,13.719616,-407230.239497287,505219.776852966,147.533172607422,111,2.16888968174179,0.18261026663758 +-160.21574,54.3907544,13.719616,-403526.085555698,505219.763530453,149.557006835938,111,2.1748067648023,0.204102801216989 +-160.15902,54.3938528,13.719616,-399822.519987788,505219.809234672,144.16374206543,111,2.15885604678478,0.146165240589194 +-160.10228,54.3969228,13.719616,-396118.243934418,505219.782299532,138.779067993164,111,2.14232396654679,0.0861160064393092 +-160.04553,54.3999644,13.719616,-392413.8993963,505219.743870809,142.211654663086,111,2.15293518956151,0.12465899717337 +-159.98878,54.4029777,13.719616,-388710.127370455,505219.763951725,152.015029907227,111,2.18188652928079,0.229818526568854 +-159.93202,54.4059627,13.719616,-385006.275274601,505219.783305687,189.825927734375,111,2.27835553107826,0.580221476091695 +-159.87525,54.4089193,13.719616,-381302.338810701,505219.791275377,152.78483581543,111,2.18408025182807,0.237786753011301 +-159.81847,54.4118475,13.719616,-377598.312667625,505219.788291109,155.981155395508,111,2.19307213295639,0.270447831807763 +-159.76168,54.4147473,13.719616,-373894.191532235,505219.774794831,159.876068115234,210,2.20378345897226,0.309354425214247 +-159.70488,54.4176187,13.719616,-370189.97008939,505219.751240184,162.820175170898,210,2.21170821764482,0.338139410664311 +-159.64808,54.4204618,13.719616,-366486.289380812,505219.784359118,172.10466003418,210,2.23579262976818,0.425620869871948 +-159.59127,54.4232764,13.719616,-362782.498682873,505219.79616515,180.137512207031,210,2.25560416061592,0.497582004684817 +-159.53444,54.4260627,13.719616,-359077.943490855,505219.755243069,207.781173706055,210,2.31760619516548,0.722791091311398 +-159.47761,54.4288205,13.719616,-355373.914950217,505219.748622152,232.145690917969,210,2.36576062671459,0.897701731340925 +-159.42078,54.43155,13.719616,-351670.405893962,505219.797309817,264.032501220703,210,2.4216573898699,1.10073472964561 +-159.36393,54.434251,13.719616,-347966.118211379,505219.773194716,284.118072509766,210,2.45349885970545,1.21639203654866 +-159.30708,54.4369235,13.719616,-344262.341152684,505219.7821593,274.029846191406,210,2.43779786694565,1.15936154933556 +-159.25022,54.4395677,13.719616,-340558.42029858,505219.793970771,322.017272949219,310,2.50787916779936,1.41391683723099 +-159.19335,54.4421834,13.719616,-336854.35208314,505219.78701298,434.139709472656,310,2.63762951128474,1.88520711920501 +-159.13647,54.4447707,13.719616,-333150.13028444,505219.772943842,457.340118408203,310,2.66023929986984,1.96733232482223 +-159.07959,54.4473295,13.719616,-329446.397720198,505219.790862695,517.554504394531,410,2.71395609270157,2.16244704868622 +-159.0227,54.4498599,13.719616,-325742.5008803,505219.801729973,592.648803710938,410,2.77279741209448,2.37617551570591 +-166.37243,53.8459308,7.27283492,-810966.041824052,501515.742157528,35.0773773193359,10,1.54502711438841,-2.08343664609479 +-166.31721,53.8520915,13.62357363,-807262.032118209,501515.746851498,284.418914794922,10,2.45395847503208,1.21806149060226 +-166.26198,53.8582248,12.93553447,-803558.492973878,501515.829292259,232.61247253418,10,2.36663299761318,0.900870431444027 +-166.20672,53.8643308,13.719616,-799854.121941955,501515.75877755,251.389022827148,10,2.40034630982695,1.02332680414178 +-166.15145,53.8704095,13.719616,-796150.210073197,501515.777685936,275.505004882812,10,2.44012949274586,1.16783067975419 +-166.09616,53.8764608,13.71210747,-792446.106843435,501515.755041799,117.742668151855,10,2.07093387308052,-0.173193189791541 +-166.04086,53.8824848,13.4808534,-788742.453403667,501515.821497056,120.262100219727,10,2.08012878395879,-0.139794648992816 +-165.98553,53.8884814,13.719616,-785037.95134281,501515.728998405,143.650894165039,10,2.15730833363276,0.14054350465973 +-165.93019,53.8944506,13.719616,-781333.891669587,501515.715495857,107.112205505371,10,2.0298389617899,-0.322461637254546 +-165.87484,53.9003925,13.719616,-777630.267689857,501515.791235856,78.1258697509766,10,1.89279486524426,-0.820244912187819 +-165.81947,53.9063069,13.719616,-773926.430783013,501515.81713381,80.5,10,1.90579588036787,-0.773021514399693 +-165.76408,53.9121939,13.719616,-770222.374238505,501515.805127211,67.3623199462891,10,1.82841703577368,-1.05408356408687 +-165.70867,53.9180535,13.719616,-766518.093327734,501515.756229452,90.405403137207,10,1.95619438714075,-0.589959752634591 +-165.65325,53.9238856,13.719616,-762814.233119908,501515.77538372,97.9704055786133,10,1.99109490594813,-0.463191106726347 +-165.59781,53.9296903,13.719616,-759110.139059549,501515.758584231,93.9061279296875,10,1.97269393347179,-0.530028690920868 +-165.54236,53.9354676,13.719616,-755406.4542686,501515.820620972,85.9225540161133,10,1.93410717779006,-0.670186801313484 +-165.48689,53.9412174,13.719616,-751702.528055427,501515.836736455,79.6827697753906,10,1.90136442176682,-0.789117836902923 +-165.4314,53.9469396,13.719616,-747998.357549684,501515.797038789,80.5892105102539,10,1.90627690124033,-0.771274309293891 +-165.37589,53.9526344,13.719616,-744293.934157585,501515.724492722,83.061897277832,10,1.91940184692655,-0.723600760329069 +-165.32037,53.9583017,13.719616,-740589.90287215,501515.720744073,88.9614868164062,10,1.94920203267734,-0.615357979862377 +-165.26484,53.9639415,13.719616,-736886.258908807,501515.785207042,94.331298828125,10,1.9746558141907,-0.52290258017327 +-165.20929,53.9695537,13.719616,-733182.351485124,501515.795949071,93.9681854248047,10,1.97298084048094,-0.528986562772222 +-165.15372,53.9751384,13.719616,-729478.173924185,501515.765030424,92.4824981689453,10,1.96605955254633,-0.554126656082977 +-165.09814,53.9806956,13.719616,-725774.369292255,501515.802853726,82.1924057006836,10,1.91483169205767,-0.740200867264917 +-165.04254,53.9862252,13.719616,-722070.286768964,501515.789184711,77.2010040283203,10,1.88762294853682,-0.83903078988122 +-164.98692,53.9917272,13.719616,-718365.921524802,501515.725156037,80.2845916748047,11,1.90463220290369,-0.77724832309619 +-164.93129,53.9972017,13.719616,-714661.91476693,501515.730486751,84.0999984741211,11,1.92479598791824,-0.704007700606143 +-164.87565,54.0026485,13.719616,-710958.265310545,501515.782729346,81.9984436035156,11,1.91380560920299,-0.743927893066314 +-164.81999,54.0080678,13.719616,-707254.316821168,501515.796807571,94.9866409301758,11,1.97766252972807,-0.511981331139497 +-164.76431,54.0134594,13.719616,-703550.068070466,501515.751960919,104.113639831543,11,2.01750762975575,-0.367252554915144 +-164.70862,54.0188234,13.719616,-699846.160261068,501515.765719741,100.167053222656,11,2.00072489761386,-0.428212228323139 +-164.65291,54.0241598,13.719616,-696141.940681564,501515.732781105,99.5570068359375,11,1.99807183114491,-0.437848922998949 +-164.59719,54.0294685,13.719616,-692438.05410603,501515.747640194,98.3700256347656,11,1.99286278456414,-0.456769666990217 +-164.54146,54.0347496,13.719616,-688734.493893151,501515.820808634,98.8169708251953,11,1.99483153672132,-0.449618597217528 +-164.4857,54.040003,13.719616,-685029.961207852,501515.734560159,100.506286621094,11,2.00219322752229,-0.422878834992648 +-164.42994,54.0452288,13.719616,-681326.393004593,501515.810553349,82.6138000488281,11,1.91705259919036,-0.732133898648966 +-164.37416,54.0504268,13.719616,-677622.492152576,501515.820656844,94.7613220214844,11,1.97663111096409,-0.515727738486481 +-164.31836,54.0555972,13.719616,-673918.250286249,501515.788080007,94.6890563964844,11,1.9762997887049,-0.516931195500649 +-164.26255,54.0607398,13.719616,-670214.313815434,501515.793040539,88.6859741210938,11,1.94785494064944,-0.620251002606024 +-164.20672,54.0658547,13.719616,-666510.028245179,501515.745755242,71.4409713745117,11,1.85394735097179,-0.961350172209917 +-164.15088,54.0709419,13.719616,-662806.036529317,501515.747309151,68.3426742553711,11,1.8346919687798,-1.03129121636448 +-164.09503,54.0760014,13.719616,-659102.33375707,501515.797320882,70.537841796875,11,1.84842216769259,-0.981419214924285 +-164.03916,54.0810331,13.719616,-655398.268827096,501515.785741883,67.5840759277344,11,1.82984438009269,-1.04889904211562 +-163.98328,54.0860371,13.719616,-651694.482991057,501515.823001596,69.5247497558594,11,1.84213943435971,-1.00423989565991 +-163.92738,54.0910132,13.719616,-647990.326778251,501515.789192402,73.4951400756836,11,1.86625862196725,-0.916632121967803 +-163.87147,54.0959617,13.719616,-644286.438132092,501515.815635522,75,11,1.8750612633917,-0.8846584157902 +-163.81554,54.1008823,13.719616,-640582.169203331,501515.772562898,77.8270645141602,11,1.89113065001264,-0.826289816923378 +-163.7596,54.1057751,13.719616,-636878.1612401,501515.768216444,79.069938659668,11,1.89801140188365,-0.801296962165735 +-163.70365,54.1106401,13.719616,-633174.409281563,501515.802283568,80.2608642578125,11,1.90450383195374,-0.777714603027146 +-163.64768,54.1154773,13.719616,-629470.260502399,501515.779678234,84.0999984741211,11,1.92479598791824,-0.704007700606143 +-163.5917,54.1202867,13.719616,-625766.357796872,501515.796008371,86.2535171508789,11,1.93577681328821,-0.664122208622779 +-163.5357,54.1250683,13.719616,-622062.048333439,501515.75732455,85.9412460327148,11,1.9342016460806,-0.669843665518327 +-163.47969,54.129822,13.719616,-618357.97658168,501515.747136331,84.3111724853516,11,1.92588512892168,-0.700051629609827 +-163.42367,54.1345478,13.719616,-614654.137537435,501515.765179694,84.5980529785156,11,1.92736036788043,-0.694693140636551 +-163.36764,54.1392458,13.719616,-610950.524630517,501515.822208166,79.2903442382812,11,1.89922030334086,-0.796905887018326 +-163.31159,54.1439159,13.719616,-607246.486570801,501515.815537447,79.2764892578125,11,1.89914440926582,-0.797181555961182 +-163.25552,54.1485581,13.719616,-603542.018344969,501515.746608748,78.3227767944336,11,1.89388807620471,-0.816274057945966 +-163.19945,54.1531725,13.719616,-599838.409124279,501515.808529094,80.9268035888672,11,1.90809238715974,-0.764679946243316 +-163.14336,54.1577589,13.719616,-596134.361246191,501515.797865338,81.5668334960938,11,1.91151360289971,-0.752253114163571 +-163.08726,54.1623174,13.719616,-592430.516005329,501515.816307036,74.5017166137695,11,1.87216627955767,-0.89517382338604 +-163.03114,54.166848,13.719616,-588726.220515045,501515.775016177,71.627799987793,11,1.85508161222473,-0.957230211588833 +-162.97501,54.1713507,13.719616,-585022.117608429,501515.763578726,70.5182571411133,11,1.84830157017081,-0.98185725954535 +-162.91887,54.1758254,13.719616,-581318.203742923,501515.77080919,69.0185165405273,11,1.83896562048449,-1.01576809355139 +-162.86272,54.1802722,13.719616,-577614.472377169,501515.807565879,69.2316741943359,11,1.84030483406081,-1.01090368759259 +-162.80655,54.1846911,13.719616,-573910.270612793,501515.787284879,73.1845550537109,11,1.86441943675932,-0.923312567598737 +-162.75037,54.1890819,13.719616,-570206.244192647,501515.77532068,69.5,11,1.84198480459011,-1.00480155511883 +-162.69418,54.1934449,13.719616,-566502.383663884,501515.804610393,70.2602081298828,11,1.84670943195652,-0.987640359981149 +-162.63797,54.1977798,13.719616,-562798.040473678,501515.757226421,71.6637344360352,11,1.85529943574057,-0.95643901440629 +-162.58176,54.2020867,13.719616,-559094.503807576,501515.814131079,74.1602630615234,11,1.87017126166995,-0.902420297789029 +-162.52553,54.2063656,13.719616,-555390.472863589,501515.80629709,70.112060546875,11,1.84579273092572,-0.990970079777539 +-162.46928,54.2106166,13.719616,-551685.941145518,501515.746341227,73.2532272338867,11,1.8648267626643,-0.921833043649458 +-162.41303,54.2148395,13.719616,-547982.202128686,501515.778834941,73.13916015625,11,1.86414996910566,-0.924291351030562 +-162.35676,54.2190344,13.719616,-544277.953579276,501515.749157245,72.6365280151367,11,1.8611550769791,-0.935169654061521 +-162.30049,54.2232012,13.719616,-540574.487515626,501515.81069378,73.8251190185547,11,1.8682041557937,-0.909565387799498 +-162.2442,54.22734,13.719616,-536870.501717058,501515.811078987,74.0747756958008,11,1.86967034507651,-0.904239769832249 +-162.18789,54.2314508,13.719616,-533165.991087635,501515.75195609,72.9120101928711,11,1.86279907195139,-0.9291981950793 +-162.13158,54.2355335,13.719616,-529462.247609454,501515.783393592,74.9332275390625,11,1.87467443902033,-0.886063472317698 +-162.07525,54.2395881,13.719616,-525757.970430407,501515.745372098,73.2555618286133,11,1.86484060349411,-0.921782769805033 +-162.01892,54.2436147,13.719616,-522054.448801753,501515.807821549,70.8151016235352,11,1.85012588272366,-0.975230835642733 +-161.96257,54.2476132,13.719616,-518350.383224071,501515.801939816,68.0827941894531,11,1.83303737134443,-1.03730118651884 +-161.90621,54.2515835,13.719616,-514646.417741905,501515.795875127,66.2406387329102,11,1.82112451153106,-1.08057209362972 +-161.84983,54.2555258,13.719616,-510941.896703214,501515.734803917,68.0995025634766,11,1.83314393959669,-1.03691410020905 +-161.79345,54.25944,13.719616,-507238.112017996,501515.762160878,74.1632690429688,11,1.87018886482619,-0.902356358101137 +-161.73706,54.2633261,13.719616,-503534.410679585,501515.800506915,77.165885925293,11,1.88742534659475,-0.839748536536015 +-161.68065,54.267184,13.719616,-499830.14096189,501515.763599594,87.0013961791992,111,1.93952622213651,-0.650503285497936 +-161.62423,54.2710139,13.719616,-496125.943000113,501515.749984217,125.538146972656,111,2.09877571388384,-0.0720636771413473 +-161.56781,54.2748155,13.719616,-492422.463323915,501515.800757318,121.622344970703,111,2.08501337268312,-0.122052428545608 +-161.51137,54.2785891,13.719616,-488718.397233685,501515.800304913,125.942604064941,111,2.10017266879249,-0.0669895381824909 +-161.45492,54.2823345,13.719616,-485014.389952112,501515.801346701,120.189056396484,111,2.07986492554535,-0.14075305806311 +-161.39846,54.2860517,13.719616,-481310.436290449,501515.804001247,132.963165283203,111,2.12373134525371,0.0185822990403865 +-161.34199,54.2897407,13.719616,-477606.531057457,501515.808398349,176.141143798828,111,2.24586081217244,0.46219138210961 +-161.2855,54.2934016,13.719616,-473902.019980591,501515.754373378,199.578659057617,210,2.30011410033299,0.65925481013886 +-161.22901,54.2970343,13.719616,-470198.194822632,501515.774303249,211.42155456543,210,2.32514926183436,0.750189662458343 +-161.17251,54.3006388,13.719616,-466494.402523604,501515.796434907,205.837356567383,210,2.31352419588218,0.707964104795872 +-161.11599,54.3042151,13.719616,-462789.990021109,501515.751257529,192.431488037109,111,2.28427613818962,0.601726811029683 +-161.05947,54.3077632,13.719616,-459086.247834394,501515.778886507,190.59130859375,111,2.280103091917,0.586569115861543 +-161.00294,54.3112831,13.719616,-455382.522896267,501515.809275935,177.752838134766,111,2.2498165437277,0.47655972819648 +-160.94639,54.3147748,13.719616,-451678.162137161,501515.774622134,138.581848144531,111,2.14170634884051,0.0838726426444578 +-160.88984,54.3182382,13.719616,-447974.457220843,501515.800667364,120.579208374023,111,2.08127242831087,-0.135640606277439 +-160.83327,54.3216734,13.719616,-444270.106041246,501515.763234536,116.650344848633,111,2.06688602701864,-0.187896122058562 +-160.7767,54.3250804,13.719616,-440566.399105848,501515.796918413,109.227890014648,111,2.03833354434805,-0.291606888808077 +-160.72011,54.3284591,13.719616,-436862.036597801,501515.757673145,104.620063781738,111,2.01961498045961,-0.359598055660943 +-160.66352,54.3318096,13.719616,-433158.307877779,501515.788947089,108.739074707031,111,2.03638563314114,-0.298682258300805 +-160.60691,54.3351318,13.719616,-429453.91310554,501515.74894614,113.434417724609,111,2.05474484609137,-0.231996356624483 +-160.5503,54.3384257,13.719616,-425750.142751192,501515.767845695,116.352897644043,111,2.0657772033954,-0.191923685947943 +-160.49368,54.3416914,13.719616,-422046.342612865,501515.791786808,118.446769714355,111,2.07352322112159,-0.163787938632841 +-160.43705,54.3449288,13.719616,-418342.508538044,501515.810012051,120.935905456543,111,2.08255526055129,-0.130980993423487 +-160.3804,54.3481378,13.719616,-414637.988472932,501515.749336417,125.852203369141,111,2.09986082340192,-0.0681222496505626 +-160.32375,54.3513186,13.719616,-410934.070735744,501515.75765794,128.727569580078,111,2.10967156970347,-0.0324868188175545 +-160.26709,54.3544711,13.719616,-407230.103277768,501515.761257857,139.964965820312,111,2.14601934242834,0.0995386664064017 +-160.21042,54.3575953,13.719616,-403526.080833255,501515.760490599,152.511337280273,111,2.18330212915985,0.234960389382035 +-160.15374,54.3606912,13.719616,-399821.99813433,501515.755722129,186.794372558594,111,2.27136378836322,0.554825470908626 +-160.09706,54.3637588,13.719616,-396118.497772362,501515.806976353,227.158309936523,210,2.35632862886169,0.863442022978983 +-160.04036,54.366798,13.719616,-392414.279762716,501515.783716244,219.603088378906,210,2.3416384435034,0.810083076761307 +-159.98365,54.3698089,13.719616,-388709.985663547,501515.757620192,241.440444946289,210,2.38281002278581,0.959630004253702 +-159.92694,54.3727914,13.719616,-385006.259051242,501515.775996298,199.011123657227,310,2.29887735182648,0.654762586560039 +-159.87022,54.3757457,13.719616,-381302.44479427,501515.802333241,201.453521728516,210,2.30417486395022,0.674004662653969 +-159.81348,54.3786715,13.719616,-377597.892696365,501515.746974145,206.185211181641,210,2.31425751190512,0.710627717900396 +-159.75674,54.381569,13.719616,-373893.89121549,501515.746793681,211.582489013672,210,2.32547972177796,0.75138998729616 +-159.7,54.3844382,13.719616,-370190.4350674,501515.800577186,217.466369628906,210,2.33739210444526,0.794659161276305 +-159.64324,54.3872789,13.719616,-366486.225131053,501515.774589245,226.96891784668,310,2.35596638700843,0.862126257173825 +-159.58647,54.3900913,13.719616,-362781.902053919,501515.747771541,256.198364257812,310,2.40857635259027,1.05322066854623 +-159.5297,54.3928753,13.719616,-359078.109332278,501515.763603146,261.211334228516,310,2.41699201749624,1.08378876555464 +-159.47292,54.395631,13.719616,-355374.192868857,501515.778486342,340.963897705078,310,2.53270839700566,1.50410368467585 +-159.41613,54.3983582,13.719616,-351670.149181877,501515.770767817,417.749145507812,310,2.62091557023121,1.82449731466483 +-159.35933,54.401057,13.719616,-347965.972022177,501515.752056873,486.383392333984,310,2.68697873743893,2.0644575942685 +-159.30253,54.4037275,13.719616,-344262.303037999,501515.785815882,613.891174316406,310,2.788091389736,2.43172760783571 +-166.36203,53.8131722,13.719616,-810965.90678806,497811.719725725,268.928558349609,10,2.42963692373718,1.1297186742373 +-166.30686,53.8193281,13.719616,-807262.270064378,497811.791265256,172.11393737793,10,2.23581603988738,0.425705902106799 +-166.25167,53.8254567,13.53423554,-803558.451485752,497811.827205099,114.992530822754,10,2.06066963228571,-0.210475842064294 +-166.03072,53.8496978,12.93624914,-788741.919657768,497811.719801514,85.6290512084961,10,1.93262113195595,-0.675584543942701 +-165.97545,53.8556898,13.719616,-785038.42053407,497811.816893234,107.07772064209,10,2.02969911780908,-0.322969590508318 +-165.92015,53.8616544,13.719616,-781334.065046454,497811.753324457,128.355743408203,10,2.10841530639027,-0.0370499257443529 +-165.86484,53.8675916,13.719616,-777630.145317061,497811.765943683,84.1126251220703,10,1.92486118734765,-0.703770877668731 +-165.80951,53.8735014,13.719616,-773926.008207101,497811.737540039,82.2523880004883,10,1.91514851550201,-0.739050074084649 +-165.75417,53.8793839,13.719616,-770222.295455785,497811.796038157,69.845947265625,10,1.84414121172095,-0.996968868919754 +-165.69881,53.8852389,13.719616,-766518.357839236,497811.803486335,77.6588516235352,10,1.89019096414913,-0.829703024192677 +-165.64343,53.8910665,13.719616,-762814.188661235,497811.771849065,94.9259185791016,10,1.97738480841289,-0.512990094225799 +-165.58804,53.8968667,13.719616,-759110.431606697,497811.816468417,92.3778991699219,10,1.96556808142985,-0.555911819457851 +-165.53263,53.9026394,13.719616,-755406.435438898,497811.812025468,87.5144577026367,10,1.94207980595716,-0.64122794019595 +-165.4772,53.9083847,13.719616,-751702.193478155,497811.77051949,88.768440246582,10,1.94825858894356,-0.61878483678909 +-165.42176,53.9141026,13.719616,-747998.349398678,497811.805648891,87.8045959472656,10,1.94351724873409,-0.636006737743113 +-165.3663,53.9197929,13.719616,-744294.253818467,497811.782841724,89.7869415283203,10,1.95321317815306,-0.600788354599654 +-165.31082,53.9254558,13.719616,-740589.898163549,497811.7250795,102.456253051758,111,2.01053846915987,-0.39256653539585 +-165.25533,53.9310912,13.719616,-736885.927972042,497811.733462963,101.140892028809,111,2.00492677964536,-0.412949793448218 +-165.19983,53.936699,13.719616,-733182.340322929,497811.796464592,94.5021133422852,111,1.97544152070641,-0.520048669845259 +-165.14431,53.9422794,13.719616,-729478.478267398,497811.825589777,86.0048217773438,10,1.93452280022719,-0.668677141991395 +-165.08877,53.9478322,13.719616,-725774.340733654,497811.800046703,82.0303726196289,10,1.91397468432046,-0.743313763980819 +-165.03321,53.9533575,13.719616,-722069.92105951,497811.731922773,78.9004211425781,10,1.89707932132615,-0.804682544792876 +-164.97765,53.9588552,13.719616,-718366.513111632,497811.82773646,84.9372406005859,11,1.92909814773772,-0.688381028183115 +-164.92206,53.9643254,13.719616,-714662.164981949,497811.773416341,86.5249481201172,11,1.93714134756566,-0.659165830650233 +-164.86646,53.969768,13.719616,-710958.170511934,497811.774940083,86.4286346435547,11,1.93665765228674,-0.66092274996366 +-164.81085,53.975183,13.719616,-707254.524863531,497811.831801451,93.1614761352539,11,1.96923636127437,-0.542587580031259 +-164.75521,53.9805704,13.719616,-703549.926357101,497811.731626872,104.199996948242,11,2.0178677062441,-0.36594465433338 +-164.69957,53.9859302,13.719616,-699846.315405052,497811.793419787,99.9565048217773,11,1.99981106174859,-0.431531541020534 +-164.64391,53.9912624,13.719616,-696142.390320961,497811.805384743,99.6091461181641,11,1.99829921720165,-0.437022991938409 +-164.58823,53.996567,13.719616,-692438.146253226,497811.768729351,97.3960494995117,11,1.98854134173121,-0.472466380822008 +-164.53254,54.0018439,13.719616,-688734.228521357,497811.777404,95.362663269043,11,1.97937837145339,-0.505748904243129 +-164.47683,54.0070932,13.719616,-685029.982074223,497811.738785607,104.893348693848,11,2.02074795037524,-0.355482785545575 +-164.42111,54.0123149,13.719616,-681326.050469309,497811.756704756,99.3888244628906,11,1.99733755394503,-0.440516027372497 +-164.36538,54.0175088,13.719616,-677622.432297268,497811.808777011,100.974227905273,11,2.00421054104221,-0.415551376489696 +-164.30963,54.0226751,13.719616,-673918.470778441,497811.81506479,98.1086196899414,11,1.99170716557897,-0.460967204990862 +-164.25386,54.0278137,13.719616,-670214.162750714,497811.765854262,93.4340133666992,11,1.97050500394319,-0.537979507751415 +-164.19808,54.0329246,13.719616,-666510.151730812,497811.762781623,76.7843780517578,11,1.88527287086439,-0.84756694276642 +-164.14229,54.0380078,13.719616,-662806.432813107,497811.805458892,73.2101211547852,11,1.86457112556414,-0.922761590563328 +-164.08648,54.0430633,13.719616,-659102.352669641,497811.794262558,74.3783950805664,11,1.87144680302035,-0.897787167528651 +-164.03065,54.0480911,13.719616,-655397.906388324,497811.730498592,76.4585189819336,11,1.88342588138634,-0.854275735733993 +-163.97482,54.0530911,13.719616,-651694.387555323,497811.800753583,70.1461868286133,11,1.84600406760526,-0.990202444635952 +-163.91897,54.0580634,13.719616,-647990.492732214,497811.818850154,76.447380065918,11,1.88336260626355,-0.854505569040471 +-163.8631,54.0630079,13.719616,-644286.218642141,497811.775132017,80.9685821533203,11,1.90831653438078,-0.763865779558515 +-163.80722,54.0679247,13.719616,-640582.207116062,497811.778394557,79.8296585083008,11,1.90216427146975,-0.786212554482033 +-163.75133,54.0728137,13.719616,-636878.454852323,497811.817326277,78.4342498779297,11,1.89450574744065,-0.814030499716102 +-163.69542,54.0776749,13.719616,-633174.308472983,497811.796276491,76.7778778076172,11,1.88523610375457,-0.847700491403678 +-163.6395,54.0825083,13.719616,-629470.411435145,497811.811403931,83.7262420654297,11,1.92286159894897,-0.711033953472082 +-163.58356,54.0873138,13.719616,-625766.111953218,497811.757193705,94.3493118286133,11,1.97473873682606,-0.522601381493171 +-163.52761,54.0920916,13.719616,-622062.050271646,497811.750710255,92.8418426513672,11,1.96774375140236,-0.548009165119679 +-163.47165,54.0968416,13.719616,-618358.223026999,497811.780687476,94.978645324707,11,1.97762597097141,-0.512114122978578 +-163.41567,54.1015637,13.719616,-614653.978396659,497811.743311139,96.065544128418,11,1.98256764700103,-0.494164545144232 +-163.35968,54.106258,13.719616,-610949.958232976,497811.743006342,79.9583740234375,11,1.90286395403251,-0.783671107704791 +-163.30368,54.1109244,13.719616,-607246.159107803,497811.768530267,76.0193634033203,11,1.88092422844016,-0.86336245327736 +-163.24766,54.115563,13.719616,-603541.926047765,497811.739783877,73.4455642700195,11,1.86596557179101,-0.917696563852759 +-163.19163,54.1201737,13.719616,-599837.904019238,497811.737538108,69.108512878418,11,1.83953154764057,-1.01371248458883 +-163.13559,54.1247565,13.719616,-596134.088004944,497811.761585815,83.6305694580078,11,1.92236505399666,-0.712837546466935 +-163.07954,54.1293114,13.719616,-592430.472984618,497811.811730594,78.1664276123047,11,1.8930202641419,-0.819426199056324 +-163.02347,54.1338384,13.719616,-588726.405515946,497811.799137862,73.3131866455078,11,1.86518209704642,-0.920542367751058 +-162.96739,54.1383376,13.719616,-585022.52749525,497811.82441303,70.8313293457031,11,1.8502253926114,-0.974869387327513 +-162.91129,54.1428088,13.719616,-581318.188476806,497811.777827732,69.8108215332031,11,1.84392274881054,-0.997762388565895 +-162.85518,54.147252,13.719616,-577614.03181979,497811.747873333,72.5531845092773,11,1.86065647927485,-0.936980703237318 +-162.79906,54.1516674,13.719616,-573910.049523987,497811.756443288,71.0565795898438,11,1.85160429826999,-0.969860808396667 +-162.74293,54.1560548,13.719616,-570206.239498278,497811.781366929,74.0798492431641,11,1.86970008986005,-0.904131728288436 +-162.68678,54.1604142,13.719616,-566501.948254973,497811.737216862,76.6128845214844,11,1.88430181409767,-0.851094098110347 +-162.63063,54.1647457,13.719616,-562798.466120033,497811.806065424,77.4973754882812,11,1.88928699501912,-0.832986498091355 +-162.57446,54.1690493,13.719616,-559094.491208899,497811.817766203,82.0570755004883,11,1.91411603472896,-0.742800338951734 +-162.51827,54.1733248,13.719616,-555390.021316681,497811.751850703,81.1665191650391,11,1.90937692160059,-0.760014150511532 +-162.46208,54.1775724,13.719616,-551686.345348021,497811.798105384,80.4776840209961,11,1.9056754698071,-0.773458879924984 +-162.40587,54.1817919,13.719616,-547982.164216959,497811.767704605,77.9793472290039,11,1.89197959535533,-0.823206205125607 +-162.34965,54.1859835,13.719616,-544278.118440753,497811.766274842,77.7463455200195,11,1.89067998409385,-0.827926764173264 +-162.29342,54.190147,13.719616,-540574.205728789,497811.77170787,80.8699111938477,11,1.90778696619652,-0.765789322357561 +-162.23718,54.1942826,13.719616,-536870.418211038,497811.806027918,78.4047393798828,11,1.89434231554567,-0.814624131006806 +-162.18092,54.1983901,13.719616,-533166.105134998,497811.766860915,80.4088821411133,11,1.90530402451727,-0.774808075238699 +-162.12465,54.2024695,13.719616,-529461.909795284,497811.735585601,81.8822021484375,11,1.91318951410837,-0.746165726301005 +-162.06838,54.206521,13.719616,-525758.472788839,497811.813433813,73.0995254516602,11,1.8639145576091,-0.925146432779185 +-162.01209,54.2105443,13.719616,-522054.496218086,497811.808409837,75.4116744995117,11,1.87743858430796,-0.876023307667386 +-161.95578,54.2145396,13.719616,-518349.972264869,497811.744274773,74.7537384033203,11,1.8736329164257,-0.889846579661509 +-161.89947,54.2185069,13.719616,-514646.192660228,497811.7777182,69.8019638061523,11,1.8438676412217,-0.997962555057827 +-161.84315,54.222446,13.719616,-510942.506495462,497811.808087211,71.7140960693359,11,1.85560452865855,-0.955330829845978 +-161.78681,54.2263571,13.719616,-507238.257581518,497811.781131521,74.3585433959961,11,1.87133087382072,-0.898208255471198 +-161.73046,54.2302401,13.719616,-503534.090513881,497811.763362952,76.9534530639648,11,1.88622811231537,-0.844097233163415 +-161.6741,54.234095,13.719616,-499830.000146912,497811.75485055,89.9032897949219,11,1.95377558398729,-0.598745536083109 +-161.61773,54.2379217,13.719616,-496125.982605038,497811.744628465,90.0179977416992,111,1.95432934875574,-0.596734104383918 +-161.56135,54.2417204,13.719616,-492422.030182883,497811.754878891,106.049880981445,111,2.02551018544918,-0.338184988479802 +-161.50496,54.2454909,13.719616,-488718.140263046,497811.76361115,121.135398864746,111,2.08327107365615,-0.128380955913214 +-161.44856,54.2492333,13.719616,-485014.306417085,497811.78198491,166.874206542969,111,2.22238921372091,0.376935837072444 +-161.39215,54.2529476,13.719616,-481310.523486704,497811.810125025,248.518005371094,210,2.39535785926667,1.0052073278613 +-161.33572,54.2566337,13.719616,-477606.139117779,497811.76519918,312.807464599609,210,2.49527710818493,1.36814255972545 +-161.27929,54.2602917,13.719616,-473902.44374073,497811.802795157,355.915252685547,210,2.55134660001628,1.57180295788321 +-161.22284,54.2639215,13.719616,-470198.136558664,497811.768741936,375.436584472656,310,2.57453659023644,1.656035621445 +-161.16639,54.2675231,13.719616,-466494.509213473,497811.805366108,355.310974121094,310,2.55060862129916,1.56912240854251 +-161.10992,54.2710966,13.719616,-462790.258480078,497811.782856712,340.770690917969,310,2.53246223480367,1.50320955329653 +-161.05344,54.2746419,13.719616,-459086.028783439,497811.761150101,328.043243408203,210,2.51593109717409,1.44316374296946 +-160.99696,54.2781589,13.719616,-455382.464508555,497811.797958639,323.570220947266,210,2.50996854546995,1.42150605329832 +-160.94046,54.2816478,13.719616,-451678.261263188,497811.777910946,302.409606933594,210,2.48059558369417,1.3148150722507 +-160.88395,54.2851085,13.719616,-447974.063437017,497811.759300843,241.975387573242,111,2.38377119414273,0.963121252967659 +-160.82744,54.288541,13.719616,-444270.514238592,497811.809259646,210.550476074219,111,2.32335622773763,0.743676850836136 +-160.77091,54.2919452,13.719616,-440566.31274866,497811.782618793,201.134384155273,111,2.30348632008671,0.67150367481173 +-160.71437,54.2953213,13.719616,-436862.099898196,497811.769213689,206.073135375977,111,2.31402137888047,0.709770015355809 +-160.65783,54.2986691,13.719616,-433158.521143004,497811.812410821,191.321838378906,111,2.28176454528156,0.592603988707628 +-160.60127,54.3019886,13.719616,-429454.274396974,497811.781481514,116.82234954834,111,2.06752593658624,-0.185571787860661 +-160.5447,54.3052799,13.719616,-425750.001734891,497811.753561826,117.894439697266,111,2.07149332277329,-0.171161108824539 +-160.48813,54.308543,13.719616,-422046.346351695,497811.792504887,127.730293273926,111,2.10629390933452,-0.0447554453578442 +-160.43154,54.3117778,13.719616,-418342.007258104,497811.759897425,150.579116821289,111,2.17776474558214,0.214847031701135 +-160.37495,54.3149843,13.719616,-414638.276035484,497811.782605323,149.678253173828,111,2.17515870607003,0.205381152355419 +-160.31835,54.3181626,13.719616,-410934.49794932,497811.808482216,184.788238525391,210,2.26667432561745,0.537792003710061 +-160.26173,54.3213125,13.719616,-407230.021441613,497811.7544143,207.424560546875,210,2.31686017866083,0.720081346432206 +-160.20511,54.3244342,13.719616,-403526.135983846,497811.766096997,260.867919921875,210,2.41642067527682,1.08171348753639 +-160.14848,54.3275276,13.719616,-399822.188947914,497811.770951068,325.6181640625,210,2.5127086232813,1.43145879800523 +-160.09184,54.3305927,13.719616,-396118.175066279,497811.769356434,360.906311035156,210,2.55739447647286,1.59377057140929 +-160.03519,54.3336295,13.719616,-392414.089069324,497811.761704556,332.106109619141,210,2.52127686520836,1.46258109830403 +-159.97853,54.336638,13.719616,-388709.925685356,497811.74839842,298.734375,310,2.47528519921564,1.29552624009006 +-159.92187,54.3396182,13.719616,-385006.328059729,497811.78782574,298.107543945312,310,2.47437296648002,1.29221275041713 +-159.86519,54.34257,13.719616,-381301.995059376,497811.752830835,295.884765625,310,2.47112260498719,1.28040650972966 +-159.80851,54.3454936,13.719616,-377598.216273469,497811.781394397,313.429046630859,310,2.49613924167613,1.37127407464289 +-159.75182,54.3483887,13.719616,-373894.340917447,497811.782756913,333.582763671875,310,2.5232036024106,1.4695795577681 +-159.69512,54.3512556,13.719616,-370190.360795237,497811.790614766,368.866790771484,310,2.56686955727639,1.62818676934501 +-159.63841,54.3540941,13.719616,-366486.272537635,497811.783280702,407.333587646484,310,2.60995022233277,1.78466804127583 +-159.58169,54.3569042,13.719616,-362782.070830613,497811.761236209,586.843505859375,310,2.76852230294607,2.36064709904125 +-166.46187,53.7680268,12.61930593,-818374.525391513,494107.839557108,215.701889038086,10,2.3338539485111,0.781807569033184 +-166.40677,53.7742324,12.38066794,-814670.325772319,494107.799668786,178.941345214844,10,2.25271069788483,0.487072122169012 +-166.07583,53.8108935,13.71763791,-792446.464224152,494107.826462083,65.5775604248047,10,1.81675525628344,-1.09644247579868 +-166.02061,53.8169081,13.719616,-788742.237214614,494107.780775698,54.2017631530762,10,1.73401341412505,-1.39698446339097 +-165.96538,53.8228954,13.719616,-785038.451450469,494107.819220222,75.3267211914062,10,1.87694906394831,-0.877801385336656 +-165.91013,53.8288554,13.719616,-781334.453271335,494107.823459347,129.439483642578,10,2.11206677179272,-0.023786761170682 +-165.85486,53.834788,13.719616,-777630.239962989,494107.783555928,125.141708374023,10,2.09740207946,-0.0770531094430127 +-165.79958,53.8406932,13.719616,-773926.455784184,494107.817048049,86.0599975585938,10,1.93480132942619,-0.667665444440477 +-165.74428,53.8465711,13.719616,-770222.445081578,494107.818234998,71.2431030273438,10,1.85274282710653,-0.965725346693862 +-165.68896,53.8524216,13.719616,-766518.205102826,494107.777203605,69.5483474731445,10,1.84228681525084,-1.00370456619664 +-165.63363,53.8582447,13.719616,-762814.380095826,494107.809848024,83.9581985473633,10,1.92406311155242,-0.706669716750525 +-165.57828,53.8640403,13.719616,-759110.318278747,494107.790288001,95.6254348754883,10,1.98057342320581,-0.50140813517663 +-165.52291,53.8698086,13.719616,-755406.011051356,494107.741460385,94.1328811645508,10,1.97374135152471,-0.526224169589801 +-165.46753,53.8755494,13.719616,-751702.106496747,494107.755726559,91.2571182250977,10,1.9602667502278,-0.575167767534277 +-165.41213,53.8812628,13.719616,-747997.948967353,494107.730796366,91.4329452514648,10,1.96110270955087,-0.572131324666337 +-165.35672,53.8869487,13.719616,-744294.184584336,494107.768873996,93.405029296875,10,1.97037026099537,-0.538468932597385 +-165.30129,53.8926072,13.719616,-740590.157711289,494107.768807968,100.498352050781,111,2.00215894035233,-0.423003375780489 +-165.24585,53.8982382,13.719616,-736886.514444088,494107.831703493,106.596069335938,111,2.02774119064566,-0.330081340813909 +-165.19038,53.9038417,13.719616,-733181.952044433,494107.736191638,95.882698059082,10,1.98174024621774,-0.49716990095286 +-165.13491,53.9094177,13.719616,-729478.412654667,494107.814589858,90.5695037841797,10,1.9569819883193,-0.587098960350347 +-165.07941,53.9149662,13.719616,-725773.944552686,494107.736821812,86.6369705200195,10,1.93770325768188,-0.657124812723003 +-165.02391,53.9204871,13.719616,-722070.491710174,494107.820918077,88.0893402099609,10,1.94492335712839,-0.630899350711752 +-164.96838,53.9259806,13.719616,-718366.098716417,494107.762087993,89.9396591186523,11,1.95395123721048,-0.598107513440075 +-164.91284,53.9314465,13.719616,-714662.062386512,494107.756461809,89.718017578125,11,1.95287966878528,-0.601999755816455 +-164.85729,53.9368848,13.719616,-710958.377887624,494107.803527126,89.8993225097656,11,1.95375641885916,-0.598815149298762 +-164.80172,53.9422956,13.719616,-707254.389606995,494107.807252118,88.9256362915039,11,1.94902698138551,-0.615993816118885 +-164.74613,53.9476788,13.719616,-703550.094522951,494107.757854148,90.1520614624023,11,1.95497566196813,-0.594386510320358 +-164.69053,53.9530344,13.719616,-699846.136769269,494107.761905403,92.4754333496094,11,1.96602637514183,-0.554247165885895 +-164.63492,53.9583625,13.719616,-696142.509727371,494107.829905726,93.2774658203125,11,1.96977673858127,-0.540624775413557 +-164.57928,53.9636629,13.719616,-692437.914147306,494107.730920586,101.97306060791,11,2.00848545436381,-0.400023671123909 +-164.52364,53.9689357,13.719616,-688734.290325106,494107.789938344,107.333312988281,11,2.03073453465557,-0.319208660984489 +-164.46798,53.9741809,13.719616,-685030.335450658,494107.798544465,107.900001525879,11,2.03302145082453,-0.310901928707949 +-164.4123,53.9793984,13.719616,-681326.046399626,494107.747003117,106.859832763672,11,2.02881449017375,-0.326182810577697 +-164.35661,53.9845883,13.719616,-677622.065531972,494107.74957612,105.774208068848,11,2.02437978245413,-0.342290934806969 +-164.30091,53.9897506,13.719616,-673918.387981343,494107.80585293,102.233116149902,11,2.00959159865116,-0.396005839347246 +-164.24519,53.9948852,13.719616,-670214.36160914,494107.803531595,96.1849594116211,11,1.98310716605836,-0.49220485793397 +-164.18945,53.9999921,13.719616,-666509.981514896,494107.74389074,77.6560974121094,11,1.89017556139709,-0.829758971384483 +-164.1337,54.0050713,13.719616,-662805.891771715,494107.728022972,77.3072738647461,11,1.88822035873981,-0.8368608255061 +-164.07794,54.0101228,13.719616,-659102.087472644,494107.755554362,73.1999969482422,11,1.86451106295236,-0.922979755112895 +-164.02216,54.0151466,13.719616,-655397.914730662,494107.727433336,74.3638153076172,11,1.87136166357079,-0.898096418310677 +-163.96637,54.0201427,13.719616,-651694.017609225,494107.74311031,69.3572006225586,11,1.84109155594004,-1.00804608917446 +-163.91057,54.0251111,13.719616,-647990.391191753,494107.80224259,80.1707229614258,11,1.90401579998434,-0.779487274438184 +-163.85475,54.0300518,13.719616,-644286.381581672,494107.80748294,87.6674346923828,11,1.94283829849864,-0.638472878789956 +-163.79891,54.0349646,13.719616,-640581.98712432,494107.738193576,89.4255523681641,11,1.95146163140088,-0.607150472344793 +-163.74307,54.0398498,13.719616,-636878.495917267,494107.820514411,80.3286437988281,11,1.90487043476302,-0.776382996984994 +-163.6872,54.0447072,13.719616,-633173.959359848,494107.744455613,77.0123825073242,11,1.88656055922773,-0.842889691087927 +-163.63133,54.0495368,13.719616,-629470.319422553,494107.797420639,74.8483810424805,11,1.87418241106623,-0.887850658285734 +-163.57544,54.0543386,13.719616,-625766.273188613,494107.788999551,93.9289245605469,11,1.9727993499093,-0.529645788330972 +-163.51954,54.0591126,13.719616,-622062.464668659,494107.814260261,100.889915466309,11,2.00384775814758,-0.416869107511549 +-163.46362,54.0638588,13.719616,-618358.239916579,494107.779828816,103.795532226562,11,2.01617866014915,-0.372079751852008 +-163.40769,54.0685772,13.719616,-614654.242936863,494107.779678816,106.40690612793,11,2.02696981589058,-0.332883194096618 +-163.35175,54.0732678,13.719616,-610950.468754127,494107.813568202,94.2640228271484,11,1.9743459698428,-0.524028023283237 +-163.29579,54.0779305,13.719616,-607246.264964023,494107.778820561,82.1103897094727,11,1.91439811336803,-0.741775748821375 +-163.23982,54.0825655,13.719616,-603542.272450912,494107.789781515,78.0414962768555,11,1.89232558745944,-0.821949463047489 +-163.18384,54.0871725,13.719616,-599838.490855244,494107.81321445,74.7201919555664,11,1.87343797892247,-0.890554648313969 +-163.12784,54.0917517,13.719616,-596134.263111,494107.781170347,83.6914901733398,11,1.92268130078121,-0.711688847879629 +-163.07183,54.0963031,13.719616,-592430.233204641,494107.78434012,83.6333770751953,11,1.92237963373936,-0.712784588679967 +-163.01581,54.1008265,13.719616,-588726.399151901,494107.800517005,80.9033126831055,11,1.90796630468444,-0.765137913781129 +-162.95977,54.1053221,13.719616,-585022.103933539,494107.763465501,74.3841094970703,11,1.87148016814234,-0.89766597588224 +-162.90372,54.1097898,13.719616,-581317.993013167,494107.751218442,71.3229827880859,11,1.85322949744945,-0.963957621098826 +-162.84766,54.1142295,13.719616,-577614.06283753,494107.752607411,75.8134918212891,11,1.87974649985543,-0.867640299654294 +-162.79159,54.1186414,13.719616,-573910.305411182,494107.789528363,79.3040618896484,11,1.89929543209797,-0.796632997928629 +-162.7355,54.1230253,13.719616,-570206.069665618,494107.753954712,77.8083953857422,11,1.89102645911041,-0.826668268019311 +-162.6794,54.1273813,13.719616,-566501.998062441,494107.74376262,79.7428359985352,11,1.90169167698242,-0.787929152551929 +-162.62329,54.1317094,13.719616,-562798.085560238,494107.758845145,79.4968566894531,11,1.90034995696573,-0.792802662617541 +-162.56717,54.1360095,13.719616,-559094.32854494,494107.78808135,84.2532424926758,11,1.92558662372236,-0.70113588569565 +-162.51103,54.1402817,13.719616,-555390.071543883,494107.758779023,390.275329589844,210,2.59137109916332,1.71718336291466 +-162.45488,54.1445259,13.719616,-551685.959895593,494107.744581009,481.751068115234,310,2.68282268622534,2.04936163000562 +-162.39872,54.1487421,13.719616,-547981.988519506,494107.745419928,486.314331054688,310,2.68691706785373,2.06423359273281 +-162.34255,54.1529304,13.719616,-544278.150939365,494107.772269229,371.812255859375,210,2.57032370110122,1.6407332056276 +-162.28637,54.1570906,13.719616,-540574.444864212,494107.803024831,324.110595703125,111,2.51069322905807,1.42413831093565 +-162.23017,54.1612229,13.719616,-536870.213451879,494107.778872681,84.2872009277344,11,1.92576163170098,-0.700500206765042 +-162.17396,54.1653271,13.719616,-533166.103345485,494107.759681547,84.8757858276367,11,1.92878380824911,-0.68952279892718 +-162.11774,54.1694034,13.719616,-529462.106711568,494107.767504761,82.0014572143555,11,1.91382157012189,-0.743869918453161 +-162.06151,54.1734516,13.719616,-525758.221173705,494107.780272124,77.8416595458984,11,1.89121208630376,-0.825994017069785 +-162.00527,54.1774718,13.719616,-522054.44026733,494107.809026551,76.483528137207,11,1.88356791346233,-0.853759834694012 +-161.94901,54.1814639,13.719616,-518350.111240921,494107.764698029,77.2158126831055,11,1.8877062466803,-0.838728227248432 +-161.89275,54.185428,13.719616,-514646.525596942,494107.815015308,77.5698318481445,11,1.88969285000417,-0.831512316943113 +-161.83647,54.189364,13.719616,-510942.381583083,494107.79343397,78.1232681274414,11,1.89278040281892,-0.820297443844637 +-161.78018,54.193272,13.719616,-507238.32173843,494107.78909775,78.8942718505859,11,1.89704547223363,-0.804805494358403 +-161.72388,54.1971519,13.719616,-503534.342240443,494107.791027841,83.4400329589844,11,1.92137446696572,-0.716435641304986 +-161.66757,54.2010037,13.719616,-499830.437945748,494107.799296292,90.2028732299805,11,1.95522037133409,-0.59349765605616 +-161.61124,54.2048275,13.719616,-496125.953460106,494107.750326405,101.936149597168,111,2.00832822509059,-0.400594772721952 +-161.55491,54.2086231,13.719616,-492422.184141015,494107.772090979,103.554191589355,111,2.01516768263348,-0.375751910750639 +-161.49857,54.2123907,13.719616,-488718.473327044,494107.811524562,153.390548706055,210,2.18579860099979,0.244028287668694 +-161.44221,54.2161301,13.719616,-485014.169402718,494107.773617034,300.214630126953,210,2.47743185255944,1.30332349775059 +-161.38584,54.2198414,13.719616,-481309.914926735,494107.743690451,435.835784912109,310,2.63932288573546,1.89135793854719 +-161.32947,54.2235246,13.719616,-477606.35371744,494107.793800374,491.424591064453,310,2.69145688494093,2.08072350418633 +-161.27308,54.2271796,13.719616,-473902.183875492,494107.768653549,556.945983886719,310,2.7458130766145,2.27816070714645 +-161.21668,54.2308066,13.719616,-470198.04677443,494107.762989133,609.943359375,310,2.7852895073829,2.42155037139243 +-161.16027,54.2344053,13.719616,-466493.940866097,494107.74381955,568.026916503906,410,2.75436891566199,2.30923795664653 +-161.10386,54.2379759,13.719616,-462790.507528574,494107.803118812,519.294921875,410,2.7154140757003,2.16774285908736 +-161.04743,54.2415184,13.719616,-459086.443637591,494107.801152741,494.084777832031,310,2.6938014739959,2.08923972084631 +-160.99099,54.2450327,13.719616,-455382.394165348,494107.797313379,478.706390380859,310,2.68006922503495,2.03936027304605 +-160.93454,54.2485188,13.719616,-451678.353908341,494107.79181505,500.526336669922,310,2.69942693410204,2.10967299761799 +-160.87808,54.2519767,13.719616,-447974.317660726,494107.784883394,427.075256347656,310,2.63050441023982,1.85932671850355 +-160.82161,54.2554065,13.719616,-444270.27907417,494107.78781617,424.003753662109,310,2.62736970137463,1.84794056117018 +-160.76513,54.258808,13.719616,-440566.235227902,494107.778741106,394.014129638672,210,2.59551179622678,1.73222355652177 +-160.70864,54.2621813,13.719616,-436862.179759589,494107.768977601,410.071929931641,210,2.61286004216478,1.79523733745095 +-160.65214,54.2655265,13.719616,-433158.106342241,494107.769860486,426.485626220703,210,2.62990439879023,1.85714730565832 +-160.59563,54.2688434,13.719616,-429454.011991852,494107.759545416,231.19905090332,210,2.36398604692714,0.891255951037395 +-160.53911,54.2721321,13.719616,-425749.890367526,494107.749388971,174.075378417969,210,2.2407373479502,0.443581497672139 +-160.48259,54.2753925,13.719616,-422046.38630805,494107.792179988,228.530624389648,210,2.35894440621006,0.872943272925453 +-160.42605,54.2786247,13.719616,-418342.195533265,494107.771640932,329.244201660156,210,2.51751813531439,1.44892831848081 +-160.3695,54.2818287,13.719616,-414637.961793846,494107.752208083,352.808715820312,210,2.54753930544479,1.55797377728948 +-160.31295,54.2850044,13.719616,-410934.32989378,494107.785028393,362.591735839844,210,2.55941790146921,1.60112022853904 +-160.25638,54.2881519,13.719616,-407229.995574642,494107.757207982,399.763854980469,210,2.601803524419,1.75507690915393 +-160.19981,54.2912711,13.719616,-403526.252594116,494107.781234441,424.119964599609,210,2.62748871648557,1.8483728580234 +-160.14323,54.294362,13.719616,-399822.446712389,494107.795601267,465.755645751953,210,2.66815812798923,1.99609576881045 +-160.08663,54.2974247,13.719616,-396117.922669809,494107.752117864,553.194763183594,210,2.74287806020945,2.26749988982622 +-160.03003,54.3004591,13.719616,-392413.974189478,494107.759957023,520.170715332031,310,2.71614589855631,2.17040104858346 +-159.97342,54.3034651,13.719616,-388709.948024218,494107.748244652,499.839630126953,410,2.69883068649058,2.10750725610716 +-159.91681,54.3064429,13.719616,-385006.485872398,494107.797520568,488.990936279297,410,2.68930080930692,2.07289202207833 +-159.86018,54.3093924,13.719616,-381302.285515367,494107.780634628,508.567016601562,410,2.70634819034139,2.1348129758025 +-159.80354,54.3123136,13.719616,-377597.990654645,494107.756557779,638.152526855469,410,2.80492449322702,2.49287024436119 +-159.7469,54.3152065,13.719616,-373894.244989765,494107.782041521,572.394592285156,410,2.75769552209715,2.32132114072706 +-159.69025,54.318071,13.21803243,-370190.395216285,494107.789053766,609.512939453125,410,2.78498292976316,2.42043679397158 +-166.50645,53.729044,9.583175578,-822078.266684497,490403.782970496,63.2560844421387,10,1.80110230554046,-1.15329846069414 +-166.39636,53.7414729,4.337346894,-814670.16560141,490403.767664441,57.7433967590332,10,1.76150232769701,-1.29713688318053 +-166.17598,53.7660038,5.924837004,-799854.379116254,490403.808035235,13.7278642654419,10,1.13760297642967,-3.56331740558756 +-166.06568,53.7781056,13.71184152,-792445.973860518,490403.728691714,63.3113975524902,10,1.80148190035824,-1.15191966396884 +-166.01051,53.7841156,13.719616,-788742.113809104,490403.756971413,82.8324279785156,10,1.91820039155592,-0.727964789164691 +-165.95532,53.7900983,13.719616,-785038.043557614,490403.747924582,101.008155822754,10,2.00435644195902,-0.41502142271557 +-165.90012,53.7960536,13.719616,-781334.409938953,490403.80926193,111.305435180664,10,2.04651637198374,-0.261884523223716 +-165.84489,53.8019816,13.719616,-777629.907199947,490403.71705473,127.743988037109,10,2.1063404702647,-0.0445863227696216 +-165.78966,53.8078823,13.719616,-773926.479255074,490403.823595233,83.8328552246094,10,1.92341425784637,-0.709026538612195 +-165.7344,53.8137556,13.719616,-770222.174760855,490403.767686286,76.2328948974609,10,1.88214241214995,-0.858937662339154 +-165.67913,53.8196016,13.719616,-766518.286118757,490403.793807585,71.6243438720703,10,1.85506065655947,-0.95730632854641 +-165.62384,53.8254201,13.719616,-762814.162963984,490403.7645811,78.9050445556641,10,1.89710476940277,-0.804590110114975 +-165.56854,53.8312113,13.719616,-759110.44622136,490403.817238724,96.745231628418,10,1.98562956874522,-0.483042771409883 +-165.51322,53.8369751,13.719616,-755406.483565866,490403.826475661,98.5061645507812,10,1.99346340965106,-0.454588025239045 +-165.45788,53.8427114,13.719616,-751702.272167125,490403.782410379,88.8547210693359,10,1.94868050788573,-0.617252306763489 +-165.40253,53.8484204,13.719616,-747998.452993856,490403.820641328,96.5979919433594,10,1.98496809849642,-0.485445420155929 +-165.34716,53.8541019,13.719616,-744294.37557253,490403.806611188,99.6758575439453,10,1.99858998072772,-0.435966855819546 +-165.29177,53.8597559,13.719616,-740590.035127237,490403.741409738,100.766258239746,111,2.00331513217449,-0.418803757072398 +-165.23637,53.8653825,13.719616,-736886.074541965,490403.748048494,104.995506286621,111,2.02117071205388,-0.353947194460566 +-165.18096,53.8709817,13.719616,-733182.48906115,490403.825968897,102.076995849609,111,2.00892788017474,-0.398416654297723 +-165.12552,53.8765533,13.719616,-729477.978562433,490403.733022922,96.8999938964844,10,1.98632374969552,-0.480521308059413 +-165.07008,53.8820975,13.719616,-725774.483144712,490403.821780736,96.9701232910156,10,1.98663794778684,-0.479380050910659 +-165.01461,53.8876142,13.719616,-722070.051272986,490403.75289808,94.8550872802734,10,1.97706062798697,-0.514167610063043 +-164.95913,53.8931033,13.719616,-718365.979045119,490403.734575395,95.4119644165039,11,1.97960283753707,-0.504933579358228 +-164.90364,53.898565,13.719616,-714662.258000778,490403.788220843,96.6863632202148,11,1.98536522490159,-0.484002943701173 +-164.84813,53.9039991,13.719616,-710958.237443633,490403.784351651,93.4166793823242,11,1.97042442566249,-0.538272191066264 +-164.7926,53.9094056,13.719616,-707253.912539225,490403.72414269,96.1103286743164,11,1.98277006243671,-0.493429314506724 +-164.73706,53.9147846,13.719616,-703549.926195372,490403.72568582,91.6114196777344,11,1.96194961333928,-0.569055128376436 +-164.68151,53.9201361,13.719616,-699846.273598305,490403.788507737,90.7103881835938,11,1.95765702545558,-0.584647032796573 +-164.62594,53.92546,13.719616,-696142.302166917,490403.79635069,97.0791549682617,11,1.98712598733214,-0.477607351981776 +-164.57035,53.9307562,13.719616,-692438.008814668,490403.739457163,107.037986755371,11,2.029537931989,-0.323555063413867 +-164.51475,53.9360249,13.719616,-688734.034692856,490403.744704751,110.803092956543,11,2.04455188345389,-0.269020106285 +-164.45914,53.941266,13.719616,-685030.376717445,490403.800684688,109.336059570312,11,2.03876341803088,-0.290045464893896 +-164.40351,53.9464795,13.719616,-681326.380495955,490403.804377455,108.989402770996,11,2.03738427278633,-0.295054914069338 +-164.34786,53.9516653,13.719616,-677622.042891868,490403.746060134,107.578758239746,11,2.03172652699975,-0.315605461647597 +-164.2922,53.9568235,13.719616,-673918.006832207,490403.739452042,102.591423034668,11,2.01111105391012,-0.390486744150996 +-164.23653,53.9619541,13.719616,-670214.267449213,490403.784156692,93.6997985839844,11,1.97173865733433,-0.533498526515081 +-164.18084,53.967057,13.719616,-666510.172034453,490403.768442812,77.837516784668,11,1.89118897237953,-0.826077973439946 +-164.12514,53.9721323,13.719616,-662806.363532745,490403.80439197,73.8748779296875,11,1.86849677626485,-0.908502506726078 +-164.06942,53.9771798,13.719616,-659102.190889535,490403.770419188,68.1040802001953,11,1.83317313181509,-1.03680806573951 +-164.01369,53.9821997,13.719616,-655398.295364473,490403.788498004,67.9882965087891,11,1.8324341597783,-1.03949222310076 +-163.95794,53.9871919,13.719616,-651694.024199464,490403.749163363,72.8397827148438,11,1.86236864160002,-0.930761640972515 +-163.90218,53.9921564,13.719616,-647990.022014442,490403.751322058,83.8195648193359,11,1.92334540170122,-0.709276643784878 +-163.84641,53.9970931,13.719616,-644286.28553347,490403.783652775,92.3739471435547,11,1.9655495014451,-0.555979307265732 +-163.79062,54.0020022,13.719616,-640582.157008051,490403.77136403,92.270149230957,11,1.96506122300774,-0.557752873918765 +-163.73482,54.0068835,13.719616,-636878.284323187,490403.789733819,75.1292572021484,11,1.87580909502101,-0.881942077860164 +-163.679,54.011737,13.719616,-633174.012989407,490403.743118749,74.5764389038086,11,1.87260164154406,-0.89359246438679 +-163.62317,54.0165628,13.719616,-629469.985978296,490403.738683274,77.8738098144531,11,1.89139142217168,-0.825342618009934 +-163.56733,54.0213609,13.719616,-625766.198356441,490403.776150997,94.0772705078125,11,1.97348470859823,-0.527156369951963 +-163.51147,54.0261312,13.719616,-622061.997239272,490403.750586189,103.751853942871,11,2.01599586586572,-0.372743712864107 +-163.4556,54.0308736,13.719616,-618358.028771341,490403.745510345,106.520751953125,11,2.0274342235568,-0.331196332897765 +-163.39972,54.0355883,13.719616,-614654.284818582,490403.782678497,111.27320098877,11,2.04639058154844,-0.262341429988895 +-163.34382,54.0402752,13.719616,-610950.112459555,490403.758855505,109.075714111328,11,2.03772806496479,-0.29380616274912 +-163.28791,54.0449343,13.719616,-607246.156252443,490403.766924135,84.3769302368164,11,1.92622372102853,-0.698821766433961 +-163.23199,54.0495656,13.719616,-603542.411217852,490403.806667047,80.0603790283203,11,1.90341764184601,-0.781659955527947 +-163.17605,54.054169,13.719616,-599838.224369813,490403.776545688,73.7062149047852,11,1.86750410909455,-0.912108157224018 +-163.1201,54.0587446,13.719616,-596134.238708033,490403.778808481,82.1684494018555,11,1.91470509149387,-0.740660716648047 +-163.06414,54.0632924,13.719616,-592430.449244191,490403.813269976,89.7159423828125,11,1.95286962335271,-0.602036243694815 +-163.00816,54.0678123,13.719616,-588726.202955641,490403.780092675,87.3104782104492,11,1.94106636691181,-0.644909040072963 +-162.95217,54.0723043,13.719616,-585022.144354941,490403.768872732,76.8000030517578,11,1.88536123728882,-0.847245970690605 +-162.89617,54.0767684,13.719616,-581318.268417172,490403.779452672,76.3861694335938,11,1.88301473184252,-0.855769148230923 +-162.84015,54.0812047,13.719616,-577613.919104579,490403.735728052,80.0538787841797,11,1.90338237927537,-0.781788039249431 +-162.78413,54.0856131,13.719616,-573910.39194949,490403.801056627,82.0401077270508,11,1.91402622196977,-0.74312656452822 +-162.72809,54.0899936,13.719616,-570206.382849178,490403.801919695,82.2445983886719,11,1.91510738422654,-0.73919947461719 +-162.67203,54.0943461,13.719616,-566501.888214667,490403.728854252,81.9663314819336,11,1.91363549806325,-0.744545785280408 +-162.61597,54.0986708,13.719616,-562798.199171568,490403.774961415,229.197189331055,111,2.36020928752965,0.877537682911279 +-162.55989,54.1029675,13.719616,-559094.014494279,490403.748056456,304.254821777344,210,2.48323746957983,1.32441115585675 +-162.5038,54.1072363,13.719616,-555389.977224979,490403.744381534,457.849273681641,310,2.6607225295716,1.96908755302653 +-162.39159,54.1156901,13.719616,-547982.326117695,490403.795419652,676.069030761719,410,2.82999104231485,2.58391910535359 +-162.33546,54.119875,13.719616,-544278.054014468,490403.757034921,691.732971191406,310,2.83993847665486,2.62005102615696 +-162.27932,54.124032,13.719616,-540573.909074576,490403.742771045,684.245178222656,210,2.8352117456822,2.60288219012093 +-162.22317,54.128161,13.719616,-536869.887612343,490403.741568358,206.564895629883,11,2.31505651791154,0.713529935774746 +-162.16701,54.132262,13.719616,-533165.984538402,490403.753406343,90.6390991210938,11,1.95731558034296,-0.585887258903763 +-162.11084,54.136335,13.719616,-529462.194760684,490403.778275446,93.1442794799805,11,1.96915618755683,-0.542878793857232 +-162.05466,54.14038,13.719616,-525758.513184433,490403.816177067,85.1358795166016,11,1.93011262697211,-0.684696150042591 +-161.99846,54.144397,13.719616,-522054.285177661,490403.788514013,79.3068008422852,11,1.89931043122219,-0.796578516828284 +-161.94225,54.148386,13.719616,-518350.155174869,490403.775034667,78.0176315307617,11,1.89219276180846,-0.822431923724069 +-161.88603,54.1523469,13.719616,-514646.11939041,490403.764734158,81.733283996582,11,1.91239894897314,-0.74903728452192 +-161.8298,54.1562798,13.719616,-510942.171383236,490403.76869469,81.6627426147461,11,1.91202396146071,-0.75039934619918 +-161.77356,54.1601847,13.719616,-507238.306045423,490403.786972676,82.7639846801758,11,1.91784139164756,-0.72926877930064 +-161.71731,54.1640615,13.719616,-503534.519555505,490403.80859281,84.8533782958984,11,1.9286691377092,-0.689939315058333 +-161.66104,54.1679103,13.719616,-499830.155958128,490403.769410871,93.452751159668,111,1.97059209111748,-0.537663182277269 +-161.60477,54.171731,13.719616,-496126.510477145,490403.809555344,98.0910491943359,111,1.99162937982785,-0.461249745041168 +-161.54848,54.1755236,13.719616,-492422.278897223,490403.779154928,151.295043945312,210,2.17982470183379,0.22232938077719 +-161.49218,54.1792882,13.719616,-488718.104352579,490403.764628409,293.023559570312,210,2.46690253973993,1.26507802822506 +-161.43587,54.1830247,13.719616,-485013.982962325,490403.755050171,466.671203613281,310,2.66901100316136,1.99919365487044 +-161.37955,54.186733,13.719616,-481309.910805651,490403.739501209,653.523986816406,410,2.8152615324687,2.53041732137172 +-160.81579,54.2222698,13.719616,-444270.051123334,490403.755635575,689.139343261719,410,2.83830704468136,2.61412519957217 +-160.75936,54.2256687,13.719616,-440566.169252109,490403.775116269,695.999755859375,410,2.84260908727012,2.62975144617975 +-160.70292,54.2290393,13.719616,-436862.275514861,490403.779983864,685.164733886719,410,2.83579500129792,2.60500074099495 +-160.59001,54.2356961,13.719616,-429454.425968925,490403.802295098,502.8994140625,310,2.70148112961661,2.11713442205267 +-160.53354,54.2389821,13.719616,-425750.461950054,490403.798193312,362.469848632812,310,2.55927188644632,1.60058986029907 +-160.47706,54.24224,13.719616,-422046.462979209,490403.802767587,384.953155517578,310,2.58540788395523,1.6955232632078 +-160.42057,54.2454696,13.719616,-418342.426009701,490403.794205312,478.861999511719,310,2.68021037461376,2.03987296860441 +-160.36407,54.248671,13.719616,-414638.344725649,490403.783902287,508.003631591797,310,2.70586681695841,2.13306449027788 +-160.30756,54.2518442,13.719616,-410934.213901154,490403.772200367,529.894165039062,310,2.72418913728129,2.19961638740146 +-160.25104,54.2549892,13.719616,-407230.028308175,490403.759452798,548.934387207031,310,2.73952043738844,2.25530404537936 +-160.19452,54.2581059,13.719616,-403526.433286789,490403.795715036,604.2451171875,310,2.78121314962649,2.40674387651281 +-160.13798,54.2611944,13.719616,-399822.123481074,490403.770350885,697.656311035156,410,2.84364152723536,2.63350156282121 +-166.16576,53.7332225,10.95081656,-799853.989389869,486699.730848893,16.7307167053223,10,1.223514545535,-3.25126206499387 +-166.11067,53.7392824,13.719616,-796150.264816248,486699.784393163,85.9767684936523,10,1.93438111777856,-0.66919177308502 +-166.05556,53.745315,13.719616,-792446.336906742,486699.796507413,80.3719863891602,10,1.90510470202441,-0.775532071425085 +-166.00043,53.7513204,13.719616,-788742.198991628,486699.77909807,77.2811508178711,10,1.88807358067102,-0.837393965346587 +-165.94529,53.7572984,13.719616,-785038.50048885,486699.829504735,101.622650146484,10,2.006990516386,-0.405453712557109 +-165.89012,53.7632491,13.719616,-781333.934527713,486699.722675653,125.583793640137,10,2.09893359810514,-0.0714901965849459 +-165.83495,53.7691726,13.719616,-777630.444731657,486699.823505153,124.234878540039,10,2.09424353972915,-0.088525827282457 +-165.77975,53.7750687,13.719616,-773926.080084152,486699.758188608,91.0393447875977,10,1.95922912343418,-0.578936724216873 +-165.72454,53.7809374,13.719616,-770222.136051375,486699.761375697,79.4643936157227,10,1.90017257368577,-0.793446969320581 +-165.66931,53.7867788,13.719616,-766517.955876724,486699.727942687,77.3466339111328,10,1.88844141815652,-0.836057874607977 +-165.61407,53.7925929,13.719616,-762814.184954108,486699.773797227,74.6104049682617,10,1.87279939724739,-0.892874159227193 +-165.55881,53.7983796,13.719616,-759110.170413355,486699.773073203,80.9322662353516,10,1.90812170151609,-0.764573468133902 +-165.50353,53.8041389,13.719616,-755405.907521694,486699.726830158,89.0829696655273,10,1.94979468622296,-0.613205293024494 +-165.44824,53.8098708,13.719616,-751702.041635119,486699.749326692,90.2832489013672,10,1.95560717905601,-0.592092660004225 +-165.39293,53.8155753,13.719616,-747997.917921466,486699.727337227,95.0493240356445,10,1.97794903263088,-0.510940670820405 +-165.33761,53.8212524,13.719616,-744294.181729675,486699.774024567,102.933029174805,111,2.01255475364191,-0.385242814652209 +-165.28227,53.826902,13.719616,-740590.180099148,486699.766346878,99.0077819824219,111,1.99566933135715,-0.446575487969812 +-165.22691,53.8325243,13.719616,-736885.904513207,486699.727314132,103.692756652832,111,2.01574842026971,-0.373642505896811 +-165.17154,53.8381191,13.719616,-733182.004058396,486699.746541055,105.489044189453,111,2.02320735731015,-0.346549517573355 +-165.11616,53.8436864,13.719616,-729478.473950052,486699.823478055,113.405685424805,111,2.05463482780843,-0.232395974430436 +-165.06075,53.8492262,13.719616,-725774.009215427,486699.739015187,110.948699951172,111,2.04512221772314,-0.266948489429458 +-165.00533,53.8547386,13.719616,-722069.903414545,486699.724383791,106.485023498535,111,2.02728853106759,-0.331725529603352 +-164.9499,53.8602235,13.719616,-718366.15360366,486699.76810774,107.381202697754,111,2.03092826386705,-0.318504981192566 +-164.89445,53.8656809,13.719616,-714662.104892023,486699.762065495,103.002372741699,111,2.01284722913972,-0.384180460163348 +-164.83899,53.8711107,13.719616,-710958.404375706,486699.803520252,98.9180603027344,111,1.99527559163509,-0.44800566302482 +-164.78351,53.8765131,13.719616,-707254.393536838,486699.807413536,96.8056259155273,11,1.98590059731946,-0.482058318268994 +-164.72801,53.8818879,13.719616,-703550.071168859,486699.753008312,94.1510543823242,11,1.97382518797309,-0.525919651679968 +-164.6725,53.8872352,13.719616,-699846.080746504,486699.757853958,91.0371932983398,11,1.9592188598393,-0.578974004523021 +-164.61698,53.8925549,13.719616,-696142.419223456,486699.810520212,92.3758773803711,11,1.9655585763246,-0.555946344713138 +-164.56144,53.8978471,13.719616,-692438.429901453,486699.817260152,108.022399902344,11,2.03351382164696,-0.309113497344252 +-164.50588,53.9031116,13.719616,-688734.111459873,486699.757359759,111.599998474121,11,2.04766418866356,-0.257715325423115 +-164.45031,53.9083486,13.719616,-685030.10562775,486699.757155298,110.947937011719,11,2.04511923128406,-0.266959337028622 +-164.39473,53.913558,13.719616,-681326.409308851,486699.805250858,109.679763793945,11,2.04012650648699,-0.285094338557092 +-164.33913,53.9187398,13.719616,-677622.367551524,486699.799198661,110.339324951172,11,2.0427303226444,-0.275636535070279 +-164.28351,53.923894,13.719616,-673917.975493136,486699.740269,100.888626098633,11,2.00384220785207,-0.416889267769058 +-164.22789,53.9290205,13.719616,-670214.530157226,486699.82059868,86.0344161987305,11,1.93467221607187,-0.66813442099599 +-164.17224,53.9341195,13.719616,-666510.07297898,486699.759010103,76.7060012817383,11,1.8848293433699,-0.849177961221771 +-164.11658,53.9391907,13.719616,-662805.904357487,486699.725134766,69.2820587158203,11,1.84062078425809,-1.00975606629492 +-164.06091,53.9442344,13.719616,-659102.014330372,486699.751560722,69.4877395629883,11,1.84190818430446,-1.00507986186592 +-164.00523,53.9492503,13.719616,-655398.403050541,486699.804977403,71.2628860473633,11,1.85286340669116,-0.965287367225641 +-163.94953,53.9542386,13.719616,-651694.412170915,486699.808882857,71.5794906616211,11,1.85478860375454,-0.958294501985513 +-163.89381,53.9591992,13.719616,-647990.038456013,486699.753628598,82.0726928710938,11,1.91419868320843,-0.742500136084055 +-163.83808,53.9641321,13.719616,-644285.927082275,486699.737577756,91.1981887817383,11,1.95998621321978,-0.576186758020639 +-163.78234,53.9690373,13.719616,-640582.073130691,486699.760415727,72.1470565795898,11,1.85821861765657,-0.94583571246989 +-163.72659,53.9739147,13.719616,-636878.473301085,486699.810843186,73.1999969482422,11,1.86451106295236,-0.922979755112895 +-163.67082,53.9787645,13.719616,-633174.469322728,486699.815213617,72.8418807983398,11,1.86238115087625,-0.930716203710758 +-163.61503,53.9835865,13.719616,-629470.059501986,486699.75292513,77.1633148193359,11,1.88741087600689,-0.839801097841452 +-163.55923,53.9883808,13.719616,-625765.887377745,486699.730599538,92.8244171142578,11,1.96766223077882,-0.548305271292672 +-163.50342,53.9931473,13.719616,-622061.949600564,486699.736973533,108.311912536621,11,2.03467622453305,-0.304891318279179 +-163.4476,53.9978861,13.719616,-618358.239629343,486699.782793385,110.144805908203,11,2.04196402197165,-0.278419957837694 +-163.39176,54.0025971,13.719616,-614654.103997777,486699.764260977,112.44123840332,11,2.05092562018662,-0.245868875226132 +-163.33591,54.0072803,13.719616,-610950.187826827,486699.774809757,108.794883728027,11,2.03660847237566,-0.297872842596347 +-163.28005,54.0119357,13.719616,-607246.486142132,486699.814215291,86.7008895874023,11,1.93802355354216,-0.65596140673693 +-163.22417,54.0165633,13.719616,-603542.343874032,486699.791383873,80.8277969360352,11,1.90756074171378,-0.766611034249769 +-163.16828,54.0211631,13.719616,-599838.406134484,486699.798107517,78.3560485839844,11,1.8940725268449,-0.815604080573363 +-163.11237,54.0257351,13.719616,-596134.01784786,486699.744429266,91.8454666137695,11,1.96305772489645,-0.56503015091426 +-163.05646,54.0302793,13.719616,-592430.474212514,486699.81025341,100.27872467041,11,2.00120880203004,-0.426454549363511 +-163.00053,54.0347957,13.719616,-588726.470054631,486699.816437694,107.059921264648,210,2.02962691965323,-0.323231834817772 +-162.94458,54.0392842,13.719616,-585022.001874652,486699.753479819,200.032333374023,210,2.30110020101879,0.662836609290849 +-162.88863,54.0437448,13.719616,-581318.364834359,486699.797965621,220.018615722656,111,2.34245942792945,0.81306512652902 +-162.83266,54.0481776,13.719616,-577614.252249394,486699.785144701,87.1960525512695,11,1.94049682445085,-0.64697778085478 +-162.77668,54.0525825,13.719616,-573910.310676009,486699.791960752,85.3305969238281,11,1.93110478371793,-0.681092353552055 +-162.72069,54.0569595,13.719616,-570206.535082723,486699.818291884,274.552947998047,210,2.43862611128492,1.16236996918025 +-162.66468,54.0613086,13.719616,-566502.270342907,486699.778724515,429.682464599609,310,2.63314763042809,1.8689276486775 +-162.60866,54.0656299,13.719616,-562798.160074799,486699.770598845,688.83447265625,310,2.83811487321587,2.61342717795829 +-162.21619,54.0950968,13.719616,-536870.093706604,486699.764843959,234.200744628906,11,2.36958827155492,0.911604829919613 +-162.16008,54.0991945,13.719616,-533166.404448147,486699.796137485,98.4965591430664,11,1.99342105921558,-0.454741854108752 +-162.10395,54.1032643,13.719616,-529462.17549084,486699.768816895,98.5811233520508,11,1.99379376272129,-0.453388088595811 +-162.04781,54.1073061,13.719616,-525758.053206236,486699.752695698,99.7279357910156,11,1.9988168299312,-0.435142874763312 +-161.99166,54.11132,13.719616,-522054.031164603,486699.758825688,90.7781143188477,11,1.95798115715298,-0.583469693955244 +-161.9355,54.1153058,13.719616,-518350.10694646,486699.765161752,87.413444519043,11,1.94157823390887,-0.643049793038264 +-161.87933,54.1192636,13.719616,-514646.274107479,486699.782776456,95.498046875,11,1.97999448948863,-0.503510987681571 +-161.82315,54.1231934,13.719616,-510942.527544566,486699.811718196,91.4315567016602,111,1.96109611407158,-0.572155281329667 +-161.76695,54.1270952,13.719616,-507238.212059733,486699.775667764,116.36018371582,111,2.06580439826344,-0.191824906425056 +-161.71074,54.130969,13.719616,-503533.972637022,486699.752189668,97.1425476074219,111,1.98740948885636,-0.476577593526426 +-161.65453,54.1348147,13.719616,-499830.455536455,486699.805585015,109.395401000977,111,2.03899906457619,-0.289189529381082 +-161.5983,54.1386324,13.719616,-496126.354162846,486699.795903482,153.933258056641,111,2.18733246148215,0.249599706747994 +-161.54206,54.142422,13.719616,-492422.314752453,486699.78802376,227.614273071289,310,2.35719949200135,0.866605246471296 +-161.48581,54.1461836,13.719616,-488718.330908344,486699.793103925,432.191436767578,310,2.63567615773133,1.87811198155638 +-161.42955,54.1499171,13.719616,-485014.398750778,486699.800221745,680.558288574219,410,2.83286532766139,2.59435933013494 +-160.52797,54.2058301,13.719616,-425750.417365409,486699.794777844,528.204223632812,310,2.72280186959542,2.19457743520078 +-160.47153,54.2090854,13.719616,-422045.928937994,486699.750537309,582.392456054688,310,2.76521574076405,2.34863672140932 +-160.35864,54.2155113,13.719616,-414638.126838669,486699.764771256,690.119140625,410,2.83892407283788,2.616366421954 +-166.3756,53.6759454,5.773997319,-814670.38524725,482995.805571783,19.3607616424561,10,1.28692243823113,-3.0209465003071 +-166.26562,53.6882464,10.88393513,-807262.477757639,482995.827914379,51.9550094604492,10,1.71562742823859,-1.46376761201345 +-166.2106,53.694356,13.57145983,-803558.237511365,482995.776033138,67.9938812255859,10,1.832469832272,-1.0393626504217 +-166.15557,53.7004385,13.719616,-799854.447343491,482995.822032232,72.0249176025391,10,1.85748277011409,-0.948508520775993 +-166.10052,53.7064937,13.719616,-796150.456019949,482995.82347906,80.37353515625,10,1.90511307079256,-0.775501673670463 +-166.04545,53.7125216,13.719616,-792446.258872924,482995.781345647,79.969856262207,10,1.90292631541721,-0.783444593355874 +-165.99037,53.7185223,13.719616,-788742.499886089,482995.826309061,77.1587600708008,10,1.88738523998356,-0.839894215195423 +-165.93527,53.7244957,13.719616,-785038.525747229,482995.828553133,107.666603088379,10,2.03208101115595,-0.314317874012435 +-165.88015,53.7304419,13.719616,-781334.329800786,482995.800010986,123.889556884766,10,2.09303469960877,-0.0929166796369909 +-165.82501,53.7363607,13.719616,-777629.911326979,482995.719830361,123.863067626953,10,2.09294183166387,-0.0932540025200341 +-165.76986,53.7422523,13.719616,-773925.91234534,482995.727433428,102.074272155762,10,2.00891629185378,-0.398458746387067 +-165.7147,53.7481165,13.719616,-770222.332092656,482995.800307034,80.8912124633789,10,1.9079013450245,-0.765373865807366 +-165.65952,53.7539534,13.719616,-766518.513257951,482995.833331302,79.1608276367188,10,1.89851032616322,-0.799484726775164 +-165.60432,53.7597629,13.719616,-762814.453075933,482995.816614533,82.7012634277344,10,1.91751214432283,-0.730464699560618 +-165.5491,53.7655451,13.719616,-759110.144896668,482995.762153245,83.1615829467773,10,1.91992274735625,-0.721708701288601 +-165.49387,53.7713,13.719616,-755406.234666336,482995.78476329,94.7175979614258,10,1.97643067580911,-0.516455776179288 +-165.43862,53.7770274,13.719616,-751702.070835935,482995.748768544,93.7159805297852,10,1.97181365347199,-0.533226119137064 +-165.38336,53.7827275,13.719616,-747998.295499837,482995.789774254,98.8177642822266,111,1.99483502390195,-0.44960593078213 +-165.32808,53.7884002,13.719616,-744294.255179604,482995.784182093,124.744918823242,111,2.09602286474056,-0.0820628109710991 +-165.27278,53.7940455,13.719616,-740589.945130062,482995.733094995,133.731887817383,111,2.12623497533913,0.027676198117817 +-165.21747,53.7996633,13.719616,-736886.013120413,482995.737631362,136.196228027344,111,2.13416507989986,0.0564806013595612 +-165.16215,53.8052538,13.719616,-733182.450653767,482995.819144537,146.189193725586,111,2.16491527085166,0.168174071874822 +-165.1068,53.8108168,13.719616,-729477.955400969,482995.735500962,143.404632568359,111,2.15656318108338,0.137836897912655 +-165.05145,53.8163523,13.719616,-725774.474525782,482995.81736687,125.894355773926,111,2.10000625980455,-0.0675939831245255 +-164.99607,53.8218604,13.719616,-722070.049456869,482995.747320503,111.592277526855,111,2.04763414134424,-0.257824465863259 +-164.94068,53.827341,13.719616,-718365.97855068,482995.73357588,115.201271057129,111,2.06145727084112,-0.207614914016621 +-164.88528,53.8327942,13.719616,-714662.255197436,482995.786589888,110.357788085938,111,2.04280298727925,-0.275372596375939 +-164.82986,53.8382198,13.719616,-710958.227582393,482995.7768891,99.4148406982422,111,1.99745122093913,-0.440103156406131 +-164.77442,53.843618,13.719616,-707253.887284996,482995.727587908,97.9899063110352,11,1.9911813424355,-0.462877144732789 +-164.71898,53.8489886,13.719616,-703550.534397361,482995.829831343,96.6882858276367,11,1.98537386075741,-0.483971575807916 +-164.66351,53.8543317,13.719616,-699846.210355193,482995.776301915,98.0734329223633,11,1.99155137743265,-0.461533072004667 +-164.60803,53.8596473,13.719616,-696142.211645061,482995.779537159,100.013175964355,11,2.00005721871666,-0.430637428652325 +-164.55254,53.8649353,13.719616,-692438.535208394,482995.828119583,98.8080291748047,11,1.99479223694218,-0.449761345232643 +-164.49703,53.8701958,13.719616,-688734.523798435,482995.828875178,103.948852539062,11,2.01681969964436,-0.369751313434504 +-164.4415,53.8754287,13.719616,-685030.174331681,482995.772076823,104.911674499512,11,2.02082381887615,-0.355207209495243 +-164.38596,53.880634,13.719616,-681326.132603965,482995.761570469,102.343338012695,11,2.01005957774117,-0.39430600571781 +-164.33041,53.8858118,13.719616,-677622.392036175,482995.807925056,93.8901824951172,11,1.97262018320219,-0.530296572950486 +-164.27484,53.8909619,13.719616,-673918.300569916,482995.787309424,84.2186508178711,11,1.92540827974576,-0.701783681923076 +-164.21926,53.8960845,13.719616,-670214.500557159,482995.823885157,77.5184631347656,11,1.88940515389427,-0.832557311330913 +-164.16366,53.9011794,13.719616,-666510.339896344,482995.794950897,74.944221496582,11,1.87473815260932,-0.885832046376807 +-164.10805,53.9062467,13.719616,-662806.462654602,482995.812594924,74.3760299682617,11,1.87143299294078,-0.897837329679435 +-164.05242,53.9112864,13.719616,-659102.213308229,482995.777213176,70.5045394897461,11,1.84821708028046,-0.982164150942924 +-163.99678,53.9162984,13.719616,-655398.239296944,482995.777831692,74.1188354492188,11,1.86992858709112,-0.903301761125575 +-163.94113,53.9212828,13.719616,-651694.534055813,482995.825097367,76.2603454589844,11,1.88229876829394,-0.858369732195686 +-163.88546,53.9262395,13.719616,-647990.443699752,482995.810119863,76.6589584350586,11,1.88456291420115,-0.850145708009146 +-163.82977,53.9311685,13.719616,-644285.96331483,482995.734251095,75.1693878173828,11,1.87604101334819,-0.881099684299733 +-163.77408,53.9360699,13.719616,-640582.38765434,482995.802761008,76.5144729614258,11,1.8837435911377,-0.853121723233654 +-163.71837,53.9409436,13.719616,-636878.41214615,482995.810886552,77.5326385498047,11,1.88948456390143,-0.832268871519043 +-163.66264,53.9457895,13.719616,-633174.033478278,482995.749014574,76.8967437744141,11,1.88590794980475,-0.845260154785483 +-163.6069,53.9506078,13.719616,-629469.894142546,482995.735313564,78.8658676147461,11,1.89688908541674,-0.805373535914574 +-163.55115,53.9553983,13.719616,-625765.992422891,482995.747520334,86.0133438110352,11,1.93456583140587,-0.66852084046811 +-163.49539,53.9601611,13.719616,-622062.321775471,482995.796372341,90.157356262207,11,1.95500116814931,-0.594293864590118 +-163.43961,53.9648961,13.719616,-618358.228189085,482995.777508605,88.5938339233398,11,1.94740349630854,-0.621890777307236 +-163.38382,53.9696034,13.719616,-614654.355782293,482995.795916621,103.072265625,11,2.01314182235066,-0.383110413535911 +-163.32801,53.9742829,13.719616,-610950.050519385,482995.748369073,104.041130065918,11,2.01720506073574,-0.368351571957604 +-163.27219,53.9789347,13.719616,-607245.956531352,482995.738761871,108.974075317383,111,2.03732319256688,-0.29527677486041 +-163.21636,53.9835587,13.719616,-603542.070408073,482995.755881222,99.1048278808594,11,1.99609481160884,-0.445030022251517 +-163.16052,53.9881549,13.719616,-599838.387171244,482995.799527314,93.1026840209961,11,1.96896220126819,-0.543583407426752 +-163.10466,53.9927233,13.719616,-596134.25118956,482995.779746588,247.24348449707,210,2.3931248556413,0.99709642133126 +-163.04879,53.9972639,13.719616,-592430.308128851,482995.787240212,219.111770629883,310,2.34066570837905,0.806549825143417 +-162.9929,54.0017767,13.719616,-588725.90235193,482995.733191357,538.654724121094,310,2.73131047305714,2.22548311157095 +-162.93701,54.0062617,13.719616,-585022.330168838,482995.795298025,671.899841308594,310,2.82730453851672,2.57416095675426 +-162.8811,54.0107188,13.719616,-581318.286768484,482995.785657979,553.917602539062,310,2.74344516649009,2.26955978170577 +-162.82518,54.0151481,13.719616,-577614.416304595,482995.803796973,423.324798583984,310,2.62667371041288,1.84541252334151 +-162.76924,54.0195495,13.719616,-573910.064591846,482995.752153493,437.904113769531,310,2.64137902507113,1.89882642349494 +-162.7133,54.0239231,13.719616,-570206.526446806,482995.815022054,529.470703125,310,2.72384193456031,2.19835524801733 +-162.65734,54.0282688,13.719616,-566502.497009874,482995.808999786,663.504272460938,310,2.82184372373434,2.55432571879296 +-162.20922,54.0620303,13.719616,-536870.184304757,482995.768778818,447.513275146484,111,2.65080592286389,1.93306760698276 +-162.15315,54.0661249,13.719616,-533166.060908255,482995.761326307,157.360107421875,11,2.1968946433825,0.284332280728511 +-162.09707,54.0701914,13.719616,-529462.049098862,482995.751080193,197.386276245117,11,2.29531695401645,0.64183020547531 +-162.04098,54.0742301,13.719616,-525758.139730406,482995.771148488,254.014694213867,11,2.40485884036566,1.03971760306283 +-161.92876,54.0822234,13.719616,-518349.966783205,482995.747030783,412.466796875,11,2.61538899406328,1.80442321258104 +-161.87264,54.0861781,13.719616,-514646.342327303,482995.792560064,359.899566650391,111,2.55618132372583,1.5893640543638 +-161.8165,54.0901048,13.719616,-510942.151997075,482995.769542689,262.221435546875,111,2.41866819063101,1.08987710480754 +-161.76035,54.0940035,13.719616,-507238.041339119,482995.756092834,326.332000732422,111,2.51365966361339,1.43491324794531 +-161.70419,54.0978742,13.719616,-503534.005247417,482995.752283882,197.932357788086,111,2.29651679804712,0.646188381464295 +-161.64802,54.1017169,13.719616,-499830.038613392,482995.758200245,213.410797119141,210,2.32921638795932,0.76496262541755 +-161.59184,54.1055315,13.719616,-496126.137593982,482995.762893264,334.105438232422,310,2.52388354470461,1.47204930225481 +-161.53565,54.1093182,13.719616,-492422.294530132,482995.788556465,454.23828125,310,2.65728373189838,1.9565968583468 +-161.47945,54.1130768,13.719616,-488718.506832456,482995.813218073,530.931030273438,410,2.72503810843158,2.20270009293983 +-166.52995,53.6245365,7.527353107,-825781.993516258,479291.738726372,27.3557262420654,10,1.43704824895209,-2.47564670559612 +-166.47507,53.6307773,11.30232002,-822078.432936321,479291.821412333,40.4178009033203,10,1.60657268024473,-1.85988558405119 +-166.42016,53.6369909,12.22008189,-818374.043215365,479291.740503377,54.19140625,10,1.73393042096425,-1.39728591823963 +-166.36524,53.6431774,13.719616,-814670.120095666,479291.754855031,71.3000030517578,10,1.85308954844039,-0.964465955845183 +-166.3103,53.6493368,13.719616,-810966.007775717,479291.741620544,75.5186996459961,10,1.878054503252,-0.873786114261865 +-166.25535,53.6554689,13.719616,-807262.35694239,479291.80146531,75.1448593139648,10,1.87589927570214,-0.88161451588615 +-166.20038,53.6615739,13.719616,-803558.507674249,479291.834508737,83.0933380126953,10,1.9195662057299,-0.72300376224264 +-166.14539,53.6676516,13.719616,-799854.459406952,479291.819872551,83.5138854980469,10,1.92175868978095,-0.71504003437197 +-166.09038,53.6737022,13.719616,-796150.203455559,479291.780373239,85.2145462036133,10,1.93051373557355,-0.683239209114381 +-166.03536,53.6797255,13.719616,-792446.390420084,479291.814468921,81.8031845092773,10,1.9127702106137,-0.747688756274779 +-165.98032,53.6857215,13.719616,-788742.364422855,479291.802705482,81.2378997802734,10,1.90975868718934,-0.758627468926434 +-165.92526,53.6916903,13.719616,-785038.118806247,479291.757008578,95.0409088134766,10,1.97791058052844,-0.511080339831818 +-165.87019,53.6976319,13.719616,-781334.300127989,479291.796039776,123.46662902832,10,2.09154959089718,-0.0983110183697146 +-165.8151,53.7035461,13.719616,-777630.256458617,479291.780184938,126.513877868652,10,2.10213816781378,-0.0598502847279005 +-165.75999,53.7094331,13.719616,-773925.979172718,479291.732334037,111.301391601562,10,2.04650059435359,-0.261941832079811 +-165.70487,53.7152928,13.719616,-770222.116765134,479291.758567134,90.1682510375977,10,1.95505364589676,-0.594103250432733 +-165.64973,53.7211252,13.719616,-766518.013336514,479291.742834455,80.0976638793945,10,1.9036198496787,-0.780925478963731 +-165.59458,53.7269302,13.719616,-762814.31732927,479291.790111304,87.914665222168,10,1.94406132665305,-0.634030491446147 +-165.53941,53.732708,13.719616,-759110.368968385,479291.807362305,90.1589126586914,10,1.95500866535862,-0.594266632585996 +-165.48422,53.7384584,13.719616,-755406.167402067,479291.773777402,99.6476516723633,111,1.9984670684379,-0.43641330833886 +-165.42902,53.7441814,13.719616,-751702.359105146,479291.803623456,105.121597290039,111,2.02169195123568,-0.352053904975785 +-165.3738,53.7498771,13.719616,-747998.286239917,479291.79463037,131.432662963867,111,2.11870330724956,0.000319029864385569 +-165.31856,53.7555453,13.719616,-744293.947862348,479291.726002244,155.31233215332,111,2.19120594106984,0.263669290211614 +-165.26331,53.7611863,13.719616,-740589.984783692,479291.74320933,153.645584106445,111,2.18652008281067,0.246648915537205 +-165.20805,53.7667998,13.719616,-736886.397910042,479291.812848067,161.799423217773,111,2.208976969107,0.328218736398996 +-165.15277,53.7723859,13.719616,-733182.529398838,479291.83492041,173.668273925781,111,2.23972048789196,0.439887971699854 +-165.09747,53.7779445,13.719616,-729478.376344164,479291.799607211,167.898284912109,111,2.2250462598247,0.386586986917881 +-165.04215,53.7834758,13.719616,-725773.930283678,479291.729964798,154.541229248047,111,2.18904436237724,0.255817819424121 +-164.98683,53.7889796,13.719616,-722070.492559025,479291.822691355,133.289703369141,111,2.12479660145675,0.0224516136242313 +-164.93148,53.794456,13.719616,-718366.102934744,479291.762053524,125.800514221191,111,2.09968241633158,-0.0687702750524887 +-164.87612,53.7999049,13.719616,-714662.060870372,479291.755162514,122.002998352051,111,2.08637050404974,-0.117122940058182 +-164.82075,53.8053263,13.719616,-710958.36156763,479291.801526565,112.321098327637,111,2.05046134153876,-0.247555267793489 +-164.76536,53.8107202,13.719616,-707254.349017069,479291.79416749,102.531265258789,111,2.01085631669822,-0.391412022413862 +-164.70995,53.8160867,13.719616,-703550.016629546,479291.745253862,101.31608581543,111,2.00567840317145,-0.410219682266741 +-164.65453,53.8214256,13.719616,-699846.014381842,479291.73944577,98.8009643554688,111,1.99476118357766,-0.449874139916103 +-164.5991,53.8267371,13.719616,-696142.333903152,479291.79822727,100.163543701172,11,2.00070968110836,-0.428267499014337 +-164.54365,53.832021,13.719616,-692438.322711492,479291.794952585,96.1552047729492,11,1.98297279708197,-0.492692924408914 +-164.48818,53.8372774,13.719616,-688733.974213542,479291.74183216,90.5574645996094,11,1.9569242547694,-0.587308665082359 +-164.4327,53.8425062,13.719616,-685029.936533873,479291.732293097,86.6754913330078,11,1.93789631219875,-0.656423583614511 +-164.37721,53.8477075,13.719616,-681326.203090884,479291.776896013,86.2842254638672,11,1.93593140498297,-0.663560687462559 +-164.3217,53.8528812,13.719616,-677622.119568717,479291.762227457,85.3949508666992,11,1.93143219298928,-0.679903109626607 +-164.26618,53.8580273,13.719616,-673918.332316274,479291.791042028,85.4862060546875,11,1.93189604317697,-0.678218273348873 +-164.21064,53.8631459,13.719616,-670214.183561888,479291.773016472,77.2802734375,11,1.88806865005582,-0.837411874748322 +-164.15509,53.8682369,13.719616,-666510.321368071,479291.7988324,75.4021530151367,11,1.87738374678813,-0.876222493191624 +-164.09952,53.8733002,13.719616,-662806.09134189,479291.757337421,71.8569259643555,11,1.85646863417014,-0.952192151987631 +-164.04394,53.8783359,13.719616,-659102.138117601,479291.76007718,71.4388122558594,11,1.85393422534558,-0.961397848230744 +-163.98835,53.8833441,13.719616,-655398.455155208,479291.817694516,75.9140167236328,11,1.88032197120125,-0.865550023470425 +-163.93274,53.8883245,13.719616,-651694.391363946,479291.798764047,78.5999984741211,11,1.89542253760835,-0.810700456149048 +-163.87711,53.8932774,13.719616,-647989.936867408,479291.737596511,81.0728454589844,11,1.90887541596102,-0.761835762138413 +-163.82148,53.8982026,13.719616,-644286.392499291,479291.80760314,83.2868881225586,11,1.9205766356897,-0.719333592223211 +-163.76583,53.9031001,13.719616,-640582.450928909,479291.81388907,80.2474212646484,11,1.90443108533202,-0.777978839521193 +-163.71016,53.9079699,13.719616,-636878.107238042,479291.757830561,76.5695648193359,11,1.8840561788022,-0.851986315614786 +-163.65448,53.9128121,13.719616,-633174.006103262,479291.74715181,79.1127319335938,11,1.898246381899,-0.800443447680015 +-163.59879,53.9176266,13.719616,-629470.144228434,479291.77058375,78.2842102050781,11,1.89367417441652,-0.817051010294338 +-163.54309,53.9224133,13.719616,-625766.518277522,479291.816862003,80.1924896240234,11,1.90413369661863,-0.779059040211402 +-163.48737,53.9271724,13.719616,-622062.468920084,479291.814058748,82.45166015625,11,1.91619940454621,-0.735232945122516 +-163.43163,53.9319037,13.719616,-618357.994396221,479291.741603636,89.3348541259766,11,1.95102093258783,-0.608751216221722 +-163.37589,53.9366073,13.719616,-614654.390593429,479291.797040244,88.669075012207,11,1.94777217796751,-0.620551620289646 +-163.32013,53.9412832,13.719616,-610950.350156524,479291.794481024,94.5142135620117,111,1.97549712498939,-0.519846699218444 +-163.26436,53.9459313,13.719616,-607246.520896012,479291.815817682,295.985748291016,310,2.47127080029009,1.28094479736895 +-163.20857,53.9505517,13.719616,-603542.245094727,479291.780970537,385.521209716797,410,2.58604827605645,1.69784935010553 +-163.15277,53.9551443,13.719616,-599838.170538764,479291.770734156,653.847717285156,410,2.81547661186599,2.53119855113245 +-163.04113,53.9642462,13.71860635,-592429.952526858,479291.745165557,694.762634277344,410,2.84183645317815,2.62694501862598 +-162.81771,53.9821163,13.719616,-577614.411332223,479291.80363319,664.809265136719,410,2.82269706337791,2.55742529194577 +-162.76182,53.9865143,13.719616,-573910.303514925,479291.791019058,654.627807617188,410,2.81599444954851,2.53307948540096 +-162.09021,54.0371163,13.719616,-529462.468345509,479291.805704928,642.063720703125,310,2.8075781311475,2.50250901471205 +-161.80987,54.057014,13.719616,-510942.347040522,479291.796950067,691.043884277344,210,2.83950562782908,2.61847879567438 +-161.69765,54.0647772,13.719616,-503533.968122266,479291.745004493,655.19775390625,210,2.81637239994315,2.53445230911207 +-161.64153,54.0686169,13.719616,-499830.207491346,479291.778688874,657.794128417969,310,2.81808999257768,2.54069109581043 +-161.5854,54.0724285,13.719616,-496126.511002044,479291.808223817,650.431884765625,310,2.81320182262039,2.52293586730291 +-161.52925,54.0762122,13.719616,-492422.219792073,479291.781657116,616.756042480469,410,2.79011341305123,2.43907217365953 +-161.47309,54.0799678,13.719616,-488717.982479824,479291.752283986,627.173461914062,410,2.79738767341981,2.46549436359887 +-166.46464,53.598016,13.719616,-822078.191692422,475587.776455348,76.3483581542969,10,1.88279970213644,-0.856550197498997 +-166.40978,53.6042249,13.719616,-818374.209097929,475587.781273619,82.6095275878906,10,1.91703013860642,-0.732215481900729 +-166.3549,53.6104066,13.719616,-814670.041460428,475587.744469022,79.7229919433594,10,1.90158358907647,-0.788321758677676 +-166.30001,53.6165612,13.719616,-810966.333880783,475587.800010482,95.96435546875,10,1.98210995077056,-0.495827028492842 +-166.2451,53.6226886,13.719616,-807262.432034006,475587.814703534,90.5143432617188,111,1.95671740468409,-0.588060003633119 +-166.19017,53.6287889,13.719616,-803558.329266055,475587.800426485,96.2062225341797,111,1.98320316273283,-0.491856170612088 +-166.13522,53.634862,13.719616,-799854.022992108,475587.747228782,95.2009429931641,10,1.97864125021955,-0.508426338959795 +-166.08026,53.6409078,13.719616,-796150.162353151,475587.765044369,92.8891220092773,10,1.96796485793383,-0.547206043087274 +-166.02528,53.6469265,13.719616,-792446.086918239,475587.755708773,92.5690689086914,10,1.96646589546904,-0.552650702605893 +-165.97029,53.6529179,13.719616,-788742.447821442,475587.817133198,84.4673233032227,10,1.92668873198235,-0.697132713922335 +-165.91527,53.6588821,13.719616,-785037.934877449,475587.72315601,83.2727203369141,10,1.92050275233709,-0.719601957648292 +-165.86025,53.6648191,13.719616,-781334.498734364,475587.829418644,109.315528869629,10,2.03868186024201,-0.290341706061971 +-165.8052,53.6707288,13.719616,-777630.181407795,475587.771384944,126.222648620605,10,2.1011372890478,-0.0634857620851874 +-165.75014,53.6766112,13.719616,-773926.28174601,475587.784828158,118.973373413086,10,2.07544977589946,-0.156790141786168 +-165.69506,53.6824664,13.719616,-770222.141350984,475587.764072034,92.5131225585938,10,1.96620333977227,-0.553604379837413 +-165.63997,53.6882943,13.719616,-766518.409262553,475587.81465132,85.9623641967773,10,1.93430835125281,-0.669456081876177 +-165.58486,53.6940948,13.719616,-762814.430949751,475587.810147508,88.9234390258789,10,1.94901625026043,-0.616032794628143 +-165.52973,53.6998681,13.719616,-759110.197850425,475587.773506651,103.642303466797,111,2.01553705668548,-0.374410238763919 +-165.47459,53.705614,13.719616,-755406.360876543,475587.797670539,136.592864990234,111,2.13542801430672,0.0610679396026449 +-165.41943,53.7113326,13.719616,-751702.261630466,475587.779803618,161.636108398438,111,2.20853838568654,0.326625676231687 +-165.36425,53.7170239,13.719616,-747997.895404627,475587.721002355,179.062744140625,111,2.2530052357807,0.488141967876313 +-165.30906,53.7226878,13.719616,-744293.911136167,475587.723498113,175.768249511719,111,2.24494042757962,0.45884828256455 +-165.25386,53.7283244,13.719616,-740590.302209723,475587.797679072,178.585876464844,111,2.25184710955856,0.483935322875362 +-165.19864,53.7339335,13.719616,-736886.415870793,475587.81013543,209.057525634766,210,2.32026580586311,0.732451556493654 +-165.1434,53.7395153,13.719616,-733182.243632571,475587.783900319,216.616683959961,210,2.33569190322515,0.788483545159118 +-165.08815,53.7450697,13.719616,-729478.434382029,475587.819006842,202.914978027344,210,2.30731410536032,0.685407283484152 +-165.03288,53.7505966,13.719616,-725774.333435288,475587.794690109,185.975845336914,111,2.26945654143243,0.547897805673526 +-164.97759,53.7560962,13.719616,-722069.932349815,475587.734022856,174.823684692383,111,2.24260026945631,0.450348160313073 +-164.9223,53.7615683,13.719616,-718366.53355959,475587.832599142,148.682647705078,111,2.17226028630495,0.194853264477315 +-164.86698,53.7670129,13.719616,-714662.176974933,475587.765412128,132.753402709961,111,2.12304566164971,0.0160917004770524 +-164.81165,53.7724302,13.719616,-710958.157728827,475587.771355756,123.539627075195,111,2.0918062860139,-0.0973786284377068 +-164.75631,53.7778199,13.719616,-707254.476451087,475587.817066645,115.350952148438,111,2.06202118369548,-0.20556662157282 +-164.70095,53.7831822,13.719616,-703550.472980531,475587.818066758,110.138626098633,111,2.04193965466293,-0.278508466858072 +-164.64557,53.788517,13.719616,-699846.144311375,475587.76460807,104.384048461914,111,2.01863413665216,-0.3631607603303 +-164.59018,53.7938243,13.719616,-696142.137399244,475587.762739354,100.333312988281,111,2.00144515281028,-0.425596055868456 +-164.53478,53.7991041,13.719616,-692438.447430931,475587.812022932,95.5300140380859,111,1.98013984156511,-0.502983027452179 +-164.47936,53.8043564,13.719616,-688734.417824408,475587.808323479,96.1105117797852,11,1.98277088983602,-0.493426309156293 +-164.42392,53.8095812,13.719616,-685030.043759886,475587.752896748,93.791145324707,11,1.97216183925179,-0.531961409002729 +-164.36847,53.8147784,13.719616,-681325.973907536,475587.738624865,90.7761001586914,11,1.95797152103801,-0.583504695075219 +-164.31301,53.8199481,13.719616,-677622.201695047,475587.776083569,89.5999984741211,11,1.95230800226613,-0.604076211783878 +-164.25753,53.8250902,13.719616,-673918.072236738,475587.752429918,88.1616897583008,11,1.9452799055285,-0.629604265153484 +-164.20204,53.8302048,13.719616,-670214.230737651,475587.780855334,80.5533294677734,11,1.90608349558824,-0.771976813825741 +-164.14653,53.8352918,13.719616,-666510.022287347,475587.749649683,81.9488830566406,11,1.91354303861862,-0.744881624373854 +-164.09101,53.8403512,13.719616,-662806.09378468,475587.759928732,78.6386795043945,11,1.89563621224054,-0.809924328896149 +-164.03548,53.845383,13.719616,-659102.44035978,475587.81134173,80.5,11,1.90579588036787,-0.773021514399693 +-163.97993,53.8503872,13.719616,-655398.405374089,475587.804859996,78.2469024658203,11,1.89346715428714,-0.817802966493683 +-163.92436,53.8553638,13.719616,-651693.9839514,475587.741826539,81.8608245849609,11,1.91307611498424,-0.746577624287185 +-163.86879,53.8603128,13.719616,-647990.474743409,475587.818739897,89.5999984741211,11,1.95230800226613,-0.604076211783878 +-163.81319,53.8652341,13.719616,-644285.919207088,475587.731581448,86.1384887695312,11,1.93519724814622,-0.666227354642881 +-163.75759,53.8701278,13.719616,-640582.266099023,475587.783757912,81.4760894775391,11,1.91103017645133,-0.75400905700773 +-163.70197,53.8749939,13.719616,-636878.206999474,475587.78150825,81.1239547729492,11,1.90914911425508,-0.760841611813085 +-163.64634,53.8798322,13.719616,-633174.39199905,475587.799577954,78.5127105712891,11,1.89493997119259,-0.812453275109256 +-163.59069,53.8846429,13.719616,-629470.161183728,475587.764899832,85.8886642456055,11,1.93393584857577,-0.670809117922006 +-163.53503,53.889426,13.719616,-625766.161421125,475587.773115462,88.9748840332031,111,1.94926743063179,-0.615120435825346 +-163.47936,53.8941813,13.719616,-622062.390971944,475587.801978024,273.390228271484,310,2.43678298761434,1.15567521792883 +-163.42367,53.8989089,13.719616,-618358.191539829,475587.769132334,285.623626708984,310,2.45579412931189,1.22472911089441 +-163.36797,53.9036089,13.719616,-614654.208393305,475587.779576271,274.114562988281,310,2.43793210907997,1.15984915508391 +-163.31226,53.9082811,13.719616,-610950.439728755,475587.811085913,386.322235107422,410,2.5869497050554,1.70112359752317 +-163.25653,53.9129256,13.719616,-607246.227268447,475587.783014935,605.570068359375,410,2.78216440105673,2.41019909322163 +-166.61858,53.5464768,7.993346803,-833190.356869224,471883.802159216,40.7334976196289,10,1.60995170278641,-1.84761200971077 +-166.56381,53.5527622,11.37703081,-829486.025359753,471883.737062491,57.5594291687012,10,1.7601164782786,-1.30217068382902 +-166.50903,53.5590206,13.719616,-825782.168238643,471883.772651859,69.4186096191406,10,1.84147591096631,-1.0066500020132 +-166.45423,53.5652518,13.719616,-822078.132771206,471883.762570087,97.4459762573242,10,1.98876391092087,-0.471657945997604 +-166.39941,53.5714559,13.719616,-818373.91228556,471883.718654524,91.9704818725586,111,1.96364846194472,-0.562884425341799 +-166.34458,53.5776329,13.719616,-814670.154517956,471883.764514805,102.039161682129,111,2.00876688194166,-0.399001445833723 +-166.28973,53.5837828,13.719616,-810966.202554414,471883.777312759,104.830024719238,111,2.02048568820452,-0.356435396606698 +-166.23486,53.5899055,13.719616,-807262.053835191,471883.747087107,105.49405670166,111,2.0232279931467,-0.346474562324952 +-166.17998,53.5960011,13.719616,-803558.354032846,471883.806717741,110.603240966797,111,2.04376785312938,-0.27186792820814 +-166.12508,53.6020695,13.719616,-799854.448239035,471883.82414556,99.6302337646484,111,1.99839114931411,-0.436689068265925 +-166.07016,53.6081107,13.719616,-796150.331821375,471883.800351092,97.6582489013672,111,1.98970893273439,-0.468225357034812 +-166.01522,53.6141247,13.719616,-792446.000143833,471883.736324432,99.8908996582031,111,1.99952592457984,-0.4325672406037 +-165.96027,53.6201115,13.719616,-788742.100890005,471883.751831878,94.7358703613281,10,1.9765144494401,-0.516151486440127 +-165.9053,53.6260712,13.719616,-785037.975112787,471883.738929927,85.8407897949219,10,1.93369370478733,-0.671688653276365 +-165.85032,53.6320035,13.719616,-781334.276430246,471883.783499923,86.0037994384766,10,1.93451763774027,-0.668695893617413 +-165.79532,53.6379087,13.719616,-777630.341926963,471883.800592025,91.0790405273438,10,1.95941844688958,-0.578249047388567 +-165.7403,53.6437866,13.719616,-773926.170882916,471883.769379841,97.3285827636719,10,1.98824039950403,-0.473559488888576 +-165.68527,53.6496372,13.719616,-770222.410936647,471883.806883662,86.934211730957,10,1.93919072054551,-0.651721923038122 +-165.63022,53.6554606,13.719616,-766518.40314122,471883.80800017,94.6023864746094,10,1.97590209221238,-0.518375742675388 +-165.57515,53.6612567,13.719616,-762814.144758263,471883.762856236,99.3083343505859,111,1.99698569774595,-0.441794069517303 +-165.52007,53.6670255,13.719616,-759110.283415661,471883.786827994,128.952575683594,111,2.11043002110754,-0.0297319068344051 +-165.46497,53.672767,13.719616,-755406.162091258,471883.765576185,188.121444702148,210,2.27443830530561,0.565992993997874 +-165.40986,53.6784812,13.719616,-751702.428405908,471883.813380928,199.938049316406,210,2.30089545062484,0.662092897418425 +-165.35473,53.6841681,13.719616,-747998.425330451,471883.817037903,205.162231445312,210,2.31209741401974,0.702781625827395 +-165.29958,53.6898276,13.719616,-744294.150036519,471883.766709042,204.693145751953,210,2.3111033003472,0.699170721220431 +-165.24442,53.6954598,13.719616,-740590.248235373,471883.785975528,231.02458190918,210,2.36365819296365,0.890065091863182 +-165.18924,53.7010646,13.719616,-736886.064750306,471883.752383953,293.514862060547,210,2.46763009654606,1.2677207222103 +-165.13405,53.706642,13.719616,-733182.247157593,471883.777469653,270.385406494141,210,2.4319832477352,1.13824119270566 +-165.07884,53.7121921,13.719616,-729478.136538868,471883.761816087,252.631607055664,210,2.40248768474323,1.03110488904696 +-165.02362,53.7177148,13.719616,-725774.382326409,471883.804911157,244.676818847656,210,2.3885928254064,0.980634793947899 +-164.96838,53.7232101,13.719616,-722070.327439702,471883.797518562,222.710708618164,210,2.34774109975503,0.832249666138761 +-164.91312,53.728678,13.719616,-718365.967118103,471883.740812561,175.587997436523,210,2.24449482577714,0.457229729630521 +-164.85785,53.7341184,13.719616,-714661.950729133,471883.732627785,174.730331420898,111,2.24236830066312,0.449505583445703 +-164.80257,53.7395314,13.719616,-710958.271678903,471883.78344338,139.114059448242,111,2.1433710238255,0.0899192173354966 +-164.74727,53.744917,13.719616,-707254.272873399,471883.786293784,130.043014526367,111,2.11408702831865,-0.0164486128298738 +-164.69195,53.7502751,13.719616,-703549.951319488,471883.731426785,122.505447387695,111,2.08815540068273,-0.110639686026936 +-164.63662,53.7556058,13.719616,-699845.952763848,471883.736410507,114.005096435547,111,2.05692426628702,-0.224080080405418 +-164.58128,53.760909,13.719616,-696142.274188462,471883.789836382,109.92505645752,111,2.04109669734549,-0.281570328439 +-164.52592,53.7661847,13.719616,-692438.258458689,471883.787005089,107.19702911377,111,2.03018274937377,-0.321212902623155 +-164.47054,53.7714329,13.719616,-688733.900759844,471883.729166083,108.289932250977,111,2.03458808200768,-0.305211477089675 +-164.41516,53.7766536,13.719616,-685030.5009205,471883.823878961,105.539512634277,111,2.02341508433862,-0.345794993714768 +-164.35975,53.7818468,13.719616,-681326.097149654,471883.761290069,99.9676895141602,111,1.99985965466857,-0.431355037665368 +-164.30433,53.7870124,13.719616,-677621.990986383,471883.737444341,96.0746154785156,11,1.98260865495379,-0.494015592554991 +-164.2489,53.7921506,13.719616,-673918.174159806,471883.773911272,95.5431976318359,11,1.98019977212237,-0.502765342562329 +-164.19345,53.7972612,13.719616,-670213.992940637,471883.747442774,91.4000015258789,11,1.96094620298417,-0.572699801188024 +-164.13799,53.8023442,13.719616,-666510.094790558,471883.75970585,88.1053924560547,11,1.94500249004927,-0.630611917356324 +-164.08252,53.8073997,13.719616,-662806.473164389,471883.82132642,85.9386291503906,11,1.9341884217569,-0.669891700036595 +-164.02703,53.8124276,13.719616,-659102.472569633,471883.821731295,92.3423461914062,11,1.96540090470761,-0.556519053030005 +-163.97152,53.8174279,13.719616,-655398.088135161,471883.762256828,92.4236526489258,11,1.96578312815072,-0.555130708387202 +-163.916,53.8224006,13.719616,-651693.96730994,471883.742380045,102.470916748047,111,2.01060062160554,-0.392340779973107 +-163.86047,53.8273457,13.719616,-647990.10521655,471883.761784613,103.12654876709,111,2.01337048389447,-0.382279849542317 +-163.80493,53.8322632,13.719616,-644286.49697444,471883.820164509,93.5726165771484,111,1.97114877385138,-0.535641151694665 +-163.74937,53.8371531,13.719616,-640582.485376684,471883.820766849,87.5970230102539,111,1.94248934689652,-0.63974037060957 +-163.69379,53.8420153,13.719616,-636878.067152722,471883.75398591,91.4170532226562,111,1.96102721794034,-0.572405531743237 +-163.6382,53.8468499,13.719616,-633173.88810142,471883.727552188,167.975372314453,210,2.22524561236891,0.387311092259319 +-163.5826,53.8516569,13.719616,-629469.943329889,471883.74120097,280.370391845703,310,2.44773214860643,1.19544569585381 +-163.52699,53.8564362,13.719616,-625766.22953079,471883.783680075,541.316162109375,410,2.73345099404124,2.23325809475072 +-161.62858,54.0024102,13.719616,-499830.359890146,471883.790071885,692.8876953125,410,2.84066284895741,2.62268215311624 +-167.86174,53.3618277,10.01417006,-918382.518983872,468179.84187364,35.9866065979004,10,1.55614089624201,-2.04306821821336 +-166.60806,53.5137242,13.63500306,-833190.515207735,468179.839787421,86.4064788818359,10,1.93654630772355,-0.661327185198061 +-166.55333,53.5200048,13.51354903,-829485.956913127,468179.73279297,77.6667022705078,10,1.89023486539496,-0.829543562337164 +-166.4986,53.5262583,13.719616,-825782.526014135,468179.837715836,83.8037338256836,10,1.92326336879455,-0.709574610716426 +-166.44384,53.5324847,13.719616,-822078.259289662,468179.78077486,97.0853118896484,111,1.98715353013674,-0.477507308654 +-166.38907,53.5386841,13.719616,-818374.455860081,468179.821947349,107.116828918457,111,2.02985770736093,-0.322393547990035 +-166.33428,53.5448564,13.719616,-814670.460336637,468179.826922796,112.355674743652,111,2.05059501220344,-0.247069737785938 +-166.27947,53.5510015,13.719616,-810966.270171981,468179.785736857,119.454925537109,111,2.07720406190912,-0.150418074275974 +-166.22465,53.5571195,13.719616,-807262.531594418,468179.83181994,114.511245727539,111,2.05884813923127,-0.217092024743871 +-166.1698,53.5632104,13.719616,-803557.934245408,468179.722474744,105.895721435547,111,2.02487841341749,-0.340479764824579 +-166.11495,53.5692742,13.719616,-799854.432167764,468179.821674925,104.969253540039,111,2.02106210884785,-0.354341672303292 +-166.06007,53.5753107,13.719616,-796150.06612637,468179.745569841,100.548271179199,111,2.0023746077643,-0.422220010182598 +-166.00518,53.5813201,13.719616,-792446.13322806,468179.757321896,106.062591552734,111,2.02556223454288,-0.337995931315182 +-165.95027,53.5873024,13.719616,-788741.975980772,468179.737500274,105.52458190918,111,2.02335364014513,-0.346018176563429 +-165.89535,53.5932574,13.719616,-785038.246608492,468179.783474139,94.2653732299805,10,1.97435219139244,-0.524005424839129 +-165.84041,53.5991852,13.719616,-781334.28558807,468179.787867609,91.7633972167969,10,1.96266948341542,-0.566440354788516 +-165.78545,53.6050858,13.719616,-777630.088270641,468179.751713113,91.8294677734375,10,1.96298206723403,-0.565304961139023 +-165.73048,53.6109592,13.719616,-773926.302884756,468179.79258842,92.0555953979492,10,1.96405019128218,-0.561425229723192 +-165.67549,53.6168053,13.719616,-770222.273836115,468179.782957777,94.4194412231445,111,1.97506142593613,-0.521429282540767 +-165.62048,53.6226242,13.719616,-766517.994504402,468179.734815135,102.182632446289,111,2.00937708685839,-0.396785007406353 +-165.56546,53.6284159,13.719616,-762814.113107551,468179.764093878,115.82080078125,111,2.06378656330566,-0.19915425893914 +-165.51042,53.6341802,13.719616,-759109.975929116,468179.734014008,173.64289855957,111,2.23965702675155,0.439657462724278 +-165.45537,53.6399173,13.719616,-755406.227312677,468179.781288494,223.535415649414,210,2.34934634000767,0.838080356917503 +-165.4003,53.6456271,13.719616,-751702.211601119,468179.781210059,229.934631347656,210,2.36160438697393,0.882605082293915 +-165.34521,53.6513095,13.719616,-747997.925978623,468179.723936941,239.666198730469,210,2.37960678772592,0.947994940221874 +-165.29011,53.6569647,13.719616,-744294.014832629,468179.744548218,293.302032470703,210,2.46731507248533,1.26657646490493 +-165.235,53.6625925,13.719616,-740590.477219713,468179.820600466,318.564514160156,310,2.50319739681743,1.39691130871411 +-165.17986,53.668193,13.719616,-736886.000774863,468179.740583899,337.22607421875,310,2.52792114676982,1.48671502540202 +-165.12471,53.6737661,13.719616,-733181.888394169,468179.717163696,322.989166259766,310,2.50918795541931,1.41867072743181 +-165.06955,53.6793119,13.719616,-729478.1334859,468179.760769768,309.617431640625,310,2.49082540372991,1.35197269850185 +-165.01437,53.6848303,13.719616,-725774.080278154,468179.750650847,298.164489746094,210,2.47445591937978,1.29251405902619 +-164.95918,53.6903214,13.719616,-722070.375071556,468179.80766048,289.532928466797,210,2.46169796301403,1.24617352002251 +-164.90397,53.695785,13.719616,-718366.363885036,468179.801219838,271.101989746094,210,2.43313270508538,1.1424163498893 +-164.84874,53.7012212,13.719616,-714662.040122373,468179.743473238,248.676406860352,210,2.3956345835956,1.00621246960898 +-164.7935,53.7066301,13.719616,-710958.050101355,468179.753635615,206.870712280273,210,2.3156990097793,0.71586364962388 +-164.73825,53.7120115,13.719616,-707254.392657264,468179.809317906,175.03401184082,111,2.24312244708379,0.452244858500404 +-164.68298,53.7173654,13.719616,-703550.410109481,468179.80412131,150.423202514648,111,2.17731483058328,0.213212812006767 +-164.62769,53.722692,13.719616,-699846.094114557,468179.761203915,145.550735473633,111,2.1630144042876,0.161269581952808 +-164.57239,53.727991,13.719616,-696142.098085307,468179.753724493,133.719039916992,111,2.12619324976132,0.0275246389095398 +-164.51708,53.7332627,13.719616,-692438.41192878,468179.814160097,135.309967041016,111,2.13132978825679,0.0461820128391139 +-164.46175,53.7385068,13.719616,-688734.383234524,468179.805475928,128.320190429688,111,2.10829499544212,-0.0374869294481867 +-164.4064,53.7437234,13.719616,-685030.005425284,468179.739904363,94.3489990234375,111,1.9747372969662,-0.522606611475162 +-164.35104,53.7489126,13.719616,-681325.924838063,468179.732286329,147.714492797852,111,2.16942310758923,0.184547821570361 +-164.29567,53.7540742,13.719616,-677622.140108617,468179.760283219,118.468803405762,111,2.07360400188662,-0.16349451983715 +-164.24028,53.7592084,13.719616,-673917.990089999,468179.743990652,200.063247680664,111,2.3011673145459,0.663080384777415 +-164.18488,53.764315,13.719616,-670214.126255989,468179.763676409,112.834579467773,111,2.05244221463523,-0.240360171309616 +-164.12946,53.7693941,13.719616,-666509.889177847,468179.729596678,149.967666625977,111,2.1759976342585,0.208428378989909 +-164.07403,53.7744456,13.719616,-662805.928580054,468179.731896289,410.8076171875,310,2.61363848768042,1.79806487375424 +-164.01859,53.7794696,13.719616,-659102.237926802,468179.781216143,113.650817871094,210,2.05557256540745,-0.228989843813865 +-163.96313,53.784466,13.719616,-655398.161155928,468179.76755363,378.755157470703,310,2.5783585552947,1.66991808943403 +-163.90766,53.7894349,13.719616,-651694.344624638,468179.801376642,546.848876953125,410,2.73786732455412,2.24929946771974 +-163.85217,53.7943761,13.719616,-647990.13388845,468179.762826781,427.273529052734,310,2.6307059877331,1.86005890549508 +-163.79667,53.7992898,13.719616,-644286.173656063,468179.77226574,391.750762939453,310,2.59300985093532,1.7231357770969 +-163.74116,53.8041759,13.719616,-640582.460697181,468179.818414124,259.723175048828,410,2.4145107033712,1.07477592441492 +-163.68563,53.8090343,13.719616,-636878.338860744,468179.794097554,384.401245117188,410,2.58478478572556,1.69325999258771 +-163.63009,53.8138651,13.719616,-633174.454506772,468179.807049652,600.329956054688,410,2.77839001489453,2.39648944536345 +-163.57453,53.8186683,13.719616,-629470.149863325,468179.762225295,664.195068359375,410,2.82229564664288,2.55596723178841 +-161.62212,53.9693036,13.719616,-499830.345258612,468179.793812369,698.286926269531,410,2.84403391100543,2.63492681267156 +-168.01292,53.3083437,9.701040353,-929493.973759712,464475.730503244,13.8830413818359,10,1.14248461818347,-3.5455858893785 +-167.95872,53.3153184,13.719616,-925790.478520611,464475.830027916,39.8632965087891,10,1.6005732099786,-1.88167737247708 +-167.90449,53.3222665,13.719616,-922086.254067061,464475.788215333,63.3075675964355,10,1.80145562737806,-1.15201509493191 +-167.85024,53.3291878,8.780711372,-918381.954091551,464475.724027341,73.4517669677734,10,1.86600224771135,-0.917563346441748 +-167.14337,53.4167256,7.43695874,-870230.249702721,464475.781077484,15.295750617981,10,1.18457079424965,-3.39271688531554 +-167.03435,53.4297899,12.28520648,-862822.40994781,464475.812167971,48.9597930908203,10,1.68983957376772,-1.55743646003813 +-166.70685,53.4683359,13.719616,-840597.923760867,464475.720461814,96.0936050415039,10,1.98269448665295,-0.493703827324817 +-166.65221,53.4746658,13.3276211,-836894.146392891,464475.768746152,61.0750122070312,10,1.7858635624477,-1.20864992517738 +-166.59755,53.4809686,13.719616,-833190.197272751,464475.77510547,90.5930938720703,10,1.95709509163299,-0.586688136832101 +-166.54287,53.4872444,13.719616,-829486.0697464,464475.751357159,95.5386810302734,111,1.98017924128868,-0.502839916410372 +-166.48818,53.4934931,13.719616,-825782.414782495,464475.81186102,96.2012939453125,111,1.98318091350902,-0.49193698614355 +-166.43346,53.4997148,13.719616,-822077.918859984,464475.719210805,102.434867858887,111,2.010447811534,-0.392895829769283 +-166.37873,53.5059094,13.719616,-818373.886360923,464475.711567604,106.84049987793,111,2.02873591130103,-0.326468231472078 +-166.32399,53.512077,13.719616,-814670.310652293,464475.799120163,116.563835144043,111,2.06656382800777,-0.189066440830809 +-166.26922,53.5182174,13.719616,-810965.884375922,464475.715098302,112.245651245117,111,2.05016952404655,-0.248615232218191 +-166.21444,53.5243307,13.719616,-807261.907759953,464475.716164889,109.960037231445,111,2.04123487821953,-0.281068416063748 +-166.15965,53.530417,13.719616,-803558.374187303,464475.812542222,119.97681427002,111,2.07909732598517,-0.143541198760411 +-166.10483,53.536476,13.719616,-799853.97824803,464475.729902131,116.948623657227,111,2.06799511505848,-0.183867597732646 +-166.05,53.542508,13.719616,-796150.016151143,464475.743436563,102.447082519531,111,2.01049959510705,-0.392707737051444 +-165.99516,53.5485128,13.719616,-792446.487307888,464475.830630739,109.887496948242,111,2.0409482810014,-0.28210941896298 +-165.94029,53.5544904,13.719616,-788742.080204291,464475.753285994,110.341728210449,111,2.04273978174592,-0.275602176913659 +-165.88541,53.5604408,13.719616,-785038.097077711,464475.750510984,101.059776306152,111,2.00457833260089,-0.414215452570399 +-165.83052,53.5663641,13.719616,-781334.531316403,464475.832590123,100.939842224121,111,2.00406262156621,-0.416088662246951 +-165.7756,53.5722602,13.719616,-777630.073381694,464475.753772647,102.357192993164,111,2.01011836744282,-0.394092464741132 +-165.72067,53.578129,13.719616,-773926.027450229,464475.738915395,113.772605895996,111,2.0560377054652,-0.227300322359907 +-165.66573,53.5839707,13.719616,-770222.38495859,464475.809267246,125.441040039062,111,2.09843964611646,-0.0732843711957575 +-165.61077,53.5897851,13.719616,-766518.491701101,464475.826930204,109.946990966797,111,2.04118334807245,-0.281255588266092 +-165.55579,53.5955723,13.719616,-762814.341066316,464475.803913278,207.235015869141,111,2.31646313868863,0.718639183926663 +-165.50079,53.6013322,13.719616,-759109.930303149,464475.730360189,254.876159667969,210,2.40632921479896,1.04505842269123 +-165.44578,53.6070648,13.719616,-755405.908154773,464475.721107125,268.165618896484,310,2.42840309685387,1.12523706282785 +-165.39076,53.6127702,13.719616,-751702.268026338,464475.786524027,349.942749023438,310,2.54399699915895,1.54510710978444 +-165.33572,53.6184483,13.719616,-747998.353690435,464475.802473794,370.283203125,310,2.56853401192636,1.63423254371637 +-165.28066,53.6240991,13.719616,-744294.160441055,464475.770074704,402.263092041016,310,2.60451018753463,1.76490828214846 +-165.22559,53.6297226,13.719616,-740590.337007474,464475.80197094,408.743865966797,310,2.61145124824507,1.79012019582476 +-165.1705,53.6353187,13.719616,-736886.227097595,464475.775717796,395.973846435547,310,2.59766650227951,1.7400500639196 +-165.1154,53.6408876,13.719616,-733182.47570567,464475.824763779,377.20166015625,310,2.57657359550514,1.66343460600012 +-165.06028,53.6464291,13.719616,-729478.428383249,464475.816846649,372.036346435547,310,2.57058537075637,1.64168366450305 +-165.00514,53.6519432,13.719616,-725774.080379971,464475.753128748,368.325317382812,310,2.56623157175135,1.62586942381888 +-164.94999,53.65743,13.719616,-722070.078557567,464475.754467188,350.335296630859,310,2.54448389512464,1.54687565490576 +-164.89483,53.6628894,13.719616,-718366.42000031,464475.809416596,344.478240966797,310,2.53716179481695,1.52027969665274 +-164.83965,53.6683214,13.719616,-714662.446508957,464475.809883795,329.035339355469,310,2.51724254494952,1.44792729561429 +-164.78445,53.6737261,13.719616,-710958.151523673,464475.768032972,301.397583007812,210,2.47913976526269,1.30952712417564 +-164.72924,53.6791033,13.719616,-707254.187317048,464475.769649417,298.981140136719,210,2.4756437936994,1.29682875760812 +-164.67401,53.6844532,13.719616,-703549.892096971,464475.73026916,270.456939697266,210,2.43209812955165,1.13865847625353 +-164.61877,53.6897756,13.719616,-699845.918093013,464475.7345755,269.416290283203,210,2.43042385184061,1.13257702172059 +-164.56352,53.6950705,13.719616,-696142.260500733,464475.782132212,264.047302246094,210,2.42168173468905,1.10082315697746 +-164.50825,53.700338,13.719616,-692438.259323198,464475.779217801,257.018432617188,210,2.40996427078993,1.05826198359871 +-164.45296,53.7055781,13.719616,-688733.909776732,464475.727094016,254.927612304688,210,2.40641687831779,1.04537684161328 +-164.39767,53.7107907,13.719616,-685030.515684107,464475.822359335,254.442672729492,210,2.40558994886635,1.04237319781646 +-164.34235,53.7159759,13.719616,-681326.110188494,464475.766142464,377.932769775391,310,2.57741455033354,1.66648919396927 +-164.28702,53.7211335,13.719616,-677621.998801907,464475.743524879,539.623046875,310,2.73209048977098,2.22831635491456 +-164.23168,53.7262637,13.719616,-673918.173263323,464475.776081896,454.175964355469,410,2.65722414700394,1.95638042900297 +-164.17632,53.7313663,13.719616,-670213.9787256,464475.740574484,291.675689697266,310,2.46490023347449,1.25780508035387 +-164.12095,53.7364414,13.719616,-666510.062083138,464475.749657956,601.164794921875,310,2.7789935397478,2.39868161989368 +-164.01017,53.7465091,13.719616,-659102.389707877,464475.800980173,322.156707763672,410,2.50806717840911,1.41459974542916 +-163.95475,53.7515017,13.719616,-655397.970859769,464475.744985913,677.421752929688,410,2.83085913831636,2.58707227781034 +-163.84388,53.7614041,13.719616,-647989.908866313,464475.736231223,617.762329101562,410,2.79082142166998,2.44164386304863 +-163.78843,53.7663139,13.719616,-644286.255970714,464475.782862861,598.8681640625,410,2.77733122652639,2.39264362380207 +-163.67748,53.7760508,13.719616,-636878.37349209,464475.795895251,623.743469238281,410,2.79500601147533,2.45684348762252 +-168.2178,53.2475716,10.20573354,-944310.427182498,460771.828611402,15.2645015716553,10,1.18368262794593,-3.39594295883854 +-168.16371,53.2546478,11.72906872,-940606.396229455,460771.820830664,20.0189685821533,10,1.30144169798753,-2.96820840466253 +-168.1096,53.2616973,13.18028619,-936902.306617776,460771.79566985,22.718225479126,10,1.3563744056164,-2.76867713119872 +-168.05547,53.2687202,13.719616,-933198.151662942,460771.764668748,22.4772968292236,10,1.35174408079643,-2.7854957925711 +-168.00132,53.2757164,13.719616,-929493.92935773,460771.717674402,46.047119140625,10,1.66320246449016,-1.65419004392214 +-167.94716,53.2826859,13.719616,-925790.289337954,460771.794794181,36.611141204834,10,1.56361326647338,-2.01592643670621 +-167.89297,53.2896287,13.719616,-922085.919245999,460771.717377364,35.6096534729004,10,1.5515677474586,-2.05967919990131 +-167.24132,53.3708542,10.42425865,-877638.497010056,460771.835299569,32.0716552734375,10,1.50612137519406,-2.2247533956522 +-167.18689,53.3774486,13.34354288,-873934.074939685,460771.74825647,51.2184753417969,10,1.70942664636006,-1.48629062167561 +-167.13245,53.3840161,13.719616,-870230.173405409,460771.764525634,67.0862197875977,10,1.82663332069327,-1.0605625263819 +-167.07799,53.3905568,13.719616,-866526.131762072,460771.763677113,71.1761093139648,10,1.85233424456054,-0.967209435121993 +-167.02351,53.3970705,13.719616,-862821.949883065,460771.724779491,77.9096908569336,10,1.8915914810863,-0.824615946929547 +-166.96902,53.4035573,13.719616,-859118.275099668,460771.788935145,67.9974975585938,10,1.83249293011077,-1.03927875247852 +-166.91451,53.4100172,13.719616,-855414.44892762,460771.826526267,70.2640762329102,10,1.84673334093151,-0.98755351575966 +-166.85998,53.4164501,13.64240936,-851710.469012046,460771.827527446,78.8084106445312,10,1.89657256903257,-0.806523213764653 +-166.80543,53.4228561,13.61055464,-848006.32870311,460771.803710351,35.4454116821289,10,1.54956002484769,-2.0669718214852 +-166.75086,53.4292351,13.42081155,-844302.025620538,460771.745064122,57.1261711120605,10,1.75683511640031,-1.31408952676489 +-166.69628,53.4355871,13.719616,-840598.209231183,460771.779056059,87.6946258544922,10,1.94297297953191,-0.637983678835331 +-166.64168,53.4419121,13.719616,-836894.221005188,460771.778897139,90.5772705078125,10,1.95701922933815,-0.586963690340229 +-166.58706,53.4482101,13.719616,-833190.056405438,460771.745498045,90.1518478393555,111,1.95497463286886,-0.594390248302631 +-166.53243,53.4544811,13.719616,-829486.36488757,460771.804680536,111.497116088867,111,2.04726363435379,-0.259170253005796 +-166.47778,53.4607251,13.719616,-825782.487910559,460771.831356491,116.043510437012,111,2.0646208581896,-0.196123861789203 +-166.42311,53.466942,13.719616,-822078.422991303,460771.815553673,114.119995117188,111,2.05736174440303,-0.22249103501937 +-166.36842,53.4731319,13.719616,-818374.163494811,460771.769126854,131.565399169922,111,2.1191416877172,0.0019113528490888 +-166.31372,53.4792947,13.719616,-814670.360909166,460771.804789665,129.104156494141,111,2.11094022455465,-0.0278787022879215 +-166.259,53.4854304,13.719616,-810966.356651723,460771.799716698,123.136627197266,111,2.09038725377327,-0.102532958567799 +-166.20426,53.4915391,13.719616,-807262.144103389,460771.765796181,133.686004638672,111,2.12608594408817,0.0271348740765489 +-166.14951,53.4976206,13.719616,-803558.376734653,460771.803171483,133.901229858398,111,2.12678456594601,0.0296724680707746 +-166.09474,53.5036751,13.719616,-799854.391902392,460771.812556159,129.845825195312,111,2.11342799074787,-0.0188424253949843 +-166.03995,53.5097024,13.719616,-796150.189037446,460771.773107589,130.596878051758,111,2.11593279515421,-0.00974426084879075 +-165.98515,53.5157026,13.719616,-792446.415511662,460771.816077903,113.932014465332,111,2.05664577633553,-0.225091635398167 +-165.93033,53.5216756,13.719616,-788742.414704943,460771.811117833,121.574363708496,111,2.08484200525142,-0.122674883970663 +-165.87549,53.5276215,13.719616,-785038.180003458,460771.770177551,118.076431274414,111,2.07216321862149,-0.16872785589658 +-165.82064,53.5335402,13.719616,-781334.362754895,460771.801014439,118.847503662109,111,2.07499006400146,-0.158459946614535 +-165.76577,53.5394318,13.719616,-777630.302359814,460771.796834488,109.494964599609,111,2.03939414751507,-0.287754475379182 +-165.71088,53.5452961,13.719616,-773925.998092591,460771.736825709,141.264556884766,111,2.15003321152855,0.114118184650635 +-165.65598,53.5511333,13.719616,-770222.095391361,460771.759891644,231.627227783203,111,2.36478960937736,0.894174719216141 +-165.60106,53.5569432,13.719616,-766517.939490891,460771.728139079,304.439331054688,210,2.48350075899404,1.32536749815943 +-165.54613,53.5627259,13.719616,-762814.177779565,460771.768443275,422.352447509766,310,2.62567501523917,1.8417849774146 +-165.49118,53.5684814,13.719616,-759110.151597589,460771.7659149,514.094055175781,410,2.71104258184937,2.15186434567223 +-165.32624,53.5855843,13.719616,-747998.409072058,460771.80647789,676.312255859375,410,2.83014725760702,2.58448652388306 +-165.27122,53.5912308,13.719616,-744293.936017143,460771.732198174,553.647399902344,410,2.74323326467631,2.2687900938353 +-165.2162,53.5968499,13.719616,-740590.486813663,460771.820686282,572.593994140625,410,2.75784678845459,2.32187058331298 +-165.16115,53.6024418,13.719616,-736886.091018033,460771.75875868,560.298522949219,310,2.74841947758831,2.28762789942423 +-165.10609,53.6080063,13.719616,-733182.055633428,460771.748141937,513.772583007812,310,2.71077092483084,2.1508776098423 +-165.05102,53.6135435,13.719616,-729478.374074875,460771.79927311,447.657897949219,310,2.65094625107735,1.93357731910772 +-164.99593,53.6190534,13.719616,-725774.387624473,460771.802365029,435.152770996094,310,2.63864175339777,1.88888387148219 +-164.94082,53.624536,13.719616,-722070.091557439,460771.758598679,419.279266357422,310,2.62250338677944,1.83026471757597 +-164.8857,53.6299912,13.719616,-718366.136954646,460771.766375854,423.668365478516,310,2.62702603725795,1.84669227500688 +-164.83057,53.635419,13.719616,-714662.519057361,460771.825219184,439.344787597656,310,2.64280547828251,1.90400770870896 +-164.77541,53.6408195,13.719616,-710957.923316169,460771.731514729,407.089660644531,310,2.60969007220979,1.78372310177491 +-164.72025,53.6461926,13.719616,-707254.308767637,460771.796682034,481.873443603516,310,2.68293299267545,2.04976229451704 +-164.66507,53.6515383,13.719616,-703550.36265008,460771.806722833,436.835021972656,310,2.64031744938476,1.89497047759817 +-164.60987,53.6568565,13.719616,-699846.081958574,460771.751905996,443.766479492188,310,2.64715449410739,1.91980457551763 +-164.55466,53.6621474,13.719616,-696142.112370964,460771.760232044,478.161651611328,410,2.67957474291858,2.03756417286016 +-164.49944,53.6674109,13.719616,-692438.450884852,460771.820318172,590.429809570312,310,2.77116827599161,2.37025802837852 +-164.4442,53.6726469,13.71961127,-688734.440461701,460771.817077519,679.6357421875,310,2.8322762104363,2.59221948822265 +-164.38894,53.6778554,9.54203033,-685030.076289075,460771.751780952,548.386291503906,410,2.73908658981073,2.25372818714467 +-168.31409,53.2007408,10.84502039,-951718.473456081,457067.839065857,17.3170433044434,10,1.23847374298273,-3.19692599008366 +-168.26008,53.2078649,13.719616,-948014.428336437,457067.827603004,46.5106468200684,10,1.66755237925422,-1.63838991190979 +-168.20605,53.2149624,13.719616,-944310.328229114,457067.805875702,42.0999984741211,10,1.62428208009503,-1.79555998902895 +-168.152,53.2220332,13.719616,-940606.171164429,457067.763716191,32.5693321228027,10,1.51280885287389,-2.20046256792289 +-168.09793,53.2290775,13.719616,-936901.948117682,457067.723508477,33.1631317138672,10,1.52065553580557,-2.17196117584873 +-168.04385,53.236095,13.719616,-933198.316333814,457067.793917493,38.1441879272461,10,1.58142837339393,-1.95121688343302 +-167.98974,53.243086,13.719616,-929493.955359532,457067.72660632,26.9297504425049,10,1.43023232883129,-2.50040407293212 +-167.93562,53.2500502,13.719616,-925790.176933179,457067.770205683,53.2368659973145,10,1.72621248106007,-1.42531967889098 +-167.88148,53.2569877,13.719616,-922086.319807311,457067.795767246,26.3866710662842,10,1.42138460322738,-2.53254153771783 +-167.82732,53.2638986,13.719616,-918382.377320001,457067.814877942,46.7522354125977,10,1.66980238107262,-1.6302172630909 +-167.77314,53.2707827,10.47045801,-914678.34969777,457067.80655367,23.2061462402344,10,1.36560302474877,-2.73515615239979 +-167.44767,53.3115257,7.601024064,-892454.08622678,457067.756049534,12.373836517334,10,1.09250437383941,-3.72712840261814 +-167.39336,53.3182224,13.34849938,-888749.989402947,457067.73076057,35.9586753845215,10,1.55580368518053,-2.04429306503826 +-167.33904,53.3248923,10.40230479,-885046.42670979,457067.816346109,27.8819580078125,10,1.44532326878501,-2.44558947163714 +-167.28469,53.3315354,12.61974786,-881342.084605888,457067.746521137,47.7751426696777,10,1.67920199265141,-1.59607519092049 +-167.23033,53.3381517,13.719616,-877638.267762838,457067.788081194,74.5015106201172,10,1.87216507875272,-0.895178185052368 +-167.17595,53.3447411,13.719616,-873934.319373967,457067.797700611,73.9969482421875,10,1.86921380907006,-0.905898038916024 +-167.12155,53.3513036,13.719616,-870230.23496813,457067.776208995,71.104850769043,10,1.85189922928629,-0.968789534763789 +-167.06713,53.3578393,13.719616,-866526.007899922,457067.735332962,73.8274307250977,10,1.86821775476503,-0.90951599245409 +-167.0127,53.3643481,13.719616,-862822.29043299,457067.794957439,81.2492904663086,10,1.90981957706122,-0.75840629953206 +-166.95825,53.3708299,13.719616,-859118.425683137,457067.814010395,81.0111312866211,10,1.9085446969554,-0.763037027963413 +-166.90378,53.3772849,13.719616,-855414.404849854,457067.81513927,75.8164367675781,10,1.87976336953195,-0.867579024174089 +-166.84929,53.3837129,13.719616,-851710.227739301,457067.777433434,80.7724761962891,10,1.90726339700663,-0.767691075096773 +-166.79478,53.390114,13.719616,-848005.887704936,457067.71266866,81.4101791381836,10,1.91067871038254,-0.755285682087961 +-166.74026,53.3964881,13.719616,-844302.036920259,457067.737971459,79.5002212524414,10,1.90036833731786,-0.792735899932333 +-166.68572,53.4028353,13.719616,-840598.014194833,457067.736891394,92.49755859375,111,1.96613027000114,-0.553869790102343 +-166.63117,53.4091555,13.719616,-836894.471676828,457067.825454122,104.482513427734,111,2.01904361142972,-0.361673431062475 +-166.57659,53.4154487,13.719616,-833190.095722161,457067.75198229,102.003379821777,10,2.00861456209162,-0.399554715005495 +-166.522,53.4217149,13.719616,-829486.190899881,457067.768877013,105.731964111328,111,2.02420629987724,-0.342921073043072 +-166.46739,53.4279541,13.719616,-825782.098112699,457067.751054453,121.177406311035,111,2.08342165259309,-0.127834010234747 +-166.41277,53.4341663,13.719616,-822078.467368061,457067.823243688,150.341598510742,111,2.17707916358138,0.212356802189808 +-166.35812,53.4403515,13.719616,-818373.985007094,457067.738266256,144.088577270508,111,2.15862955315946,0.145342551094285 +-166.30346,53.4465096,13.719616,-814669.95762952,457067.733184456,144.667098999023,111,2.16036977266803,0.151663525057524 +-166.24879,53.4526406,13.719616,-810966.380650697,457067.807290243,149.939682006836,111,2.17591658545619,0.208133986606267 +-166.19409,53.4587446,13.719616,-807261.938346413,457067.727691747,151.553131103516,111,2.18056491336568,0.225018040338424 +-166.13938,53.4648215,13.719616,-803557.93727857,457067.728127425,152.990798950195,111,2.18466531261292,0.239911860774848 +-166.08466,53.4708713,13.719616,-799854.372851603,457067.807917357,153.395431518555,111,2.1858124254811,0.244078502130716 +-166.02991,53.476894,13.719616,-796149.931357883,457067.726626725,160.26985168457,111,2.20485183502766,0.313235071992323 +-165.97515,53.4828896,13.719616,-792445.917303069,457067.725589731,162.603622436523,111,2.21113021645282,0.336039945356977 +-165.92038,53.488858,13.719616,-788742.328063343,457067.79322834,165.101959228516,111,2.21775222697015,0.360092977665904 +-165.86559,53.4947994,13.719616,-785038.500500426,457067.83254253,174.798980712891,111,2.24253889584954,0.45012523385551 +-165.81078,53.5007135,13.719616,-781334.435921507,457067.811788309,195.977462768555,210,2.2922061307543,0.630530807469821 +-165.75595,53.5066006,13.719616,-777630.123788822,457067.764800226,252.532531738281,210,2.40231733272938,1.03048612190936 +-165.70111,53.5124604,13.719616,-773926.219902678,457067.776378681,430.382537841797,410,2.63385464213603,1.87149571700197 +-164.98673,53.586161,13.719616,-725774.348786172,457067.801004722,608.12890625,410,2.78399564726484,2.41685070213917 +-164.93167,53.5916393,13.719616,-722070.419054867,457067.810070855,562.959350585938,410,2.75047703702974,2.29510154260143 +-164.87659,53.5970903,13.65020929,-718366.172604683,457067.770280223,592.197875976562,410,2.77246684538136,2.3749748030507 +-164.8215,53.6025139,13.39183714,-714662.261061948,457067.779489414,563.267517089844,410,2.75071470675568,2.29596482688374 +-168.30227,53.1681391,13.719616,-951718.016459904,453363.737301207,47.3710746765137,10,1.6755132373939,-1.60947380289136 +-168.24831,53.1752578,13.719616,-948014.509664571,453363.839268002,60.8243370056152,10,1.78407738375375,-1.21513783601996 +-168.19432,53.18235,13.719616,-944310.287770186,453363.796128607,65.4092178344727,10,1.81563895585565,-1.10049719757628 +-168.14031,53.1894155,13.719616,-940606.00628984,453363.730185361,61.9531211853027,10,1.79206319092852,-1.1861311049849 +-168.08629,53.1964544,13.719616,-936902.313652632,453363.794052401,41.8431243896484,10,1.62162410546063,-1.8052145115626 +-168.03224,53.2034667,13.719616,-933197.895310743,453363.705721973,40.2595977783203,10,1.60486943166718,-1.86607226904042 +-167.97818,53.2104524,13.719616,-929494.057160212,453363.747499824,39.5237884521484,10,1.59685856610302,-1.89517001929811 +-167.9241,53.2174113,13.719616,-925790.144377537,453363.75731677,66.4217910766602,10,1.82231058225638,-1.07626394621707 +-167.87,53.2243437,13.719616,-922086.145670075,453363.768463966,51.3968658447266,10,1.71093663674156,-1.48080590561584 +-167.81588,53.2312493,13.719616,-918382.063602084,453363.749103395,73.1638946533203,10,1.86429681574131,-0.923757962135649 +-167.76174,53.2381282,13.719616,-914677.89149331,453363.710830993,63.6187171936035,10,1.80358490775537,-1.14428094084437 +-167.70759,53.2449804,13.719616,-910974.28008166,453363.791567175,48.5352935791016,10,1.68605766091797,-1.57117344697381 +-167.59922,53.2586046,11.8247454,-903566.103643338,453363.751314862,32.1663208007812,10,1.50740138893129,-2.22010402040629 +-167.54501,53.2653766,11.53615717,-899862.184943306,453363.768477224,32.0314903259277,10,1.50557714550957,-2.22673019320488 +-167.43653,53.2788403,13.719616,-892454.011707722,453363.733239989,60.6422958374023,10,1.78277563475198,-1.21986615995052 +-167.38227,53.285532,13.719616,-888750.403457813,453363.816251509,68.2361068725586,10,1.83401424072693,-1.03375291809535 +-167.32798,53.2921969,13.719616,-885046.017113558,453363.740195048,68.0757141113281,10,1.83299220576643,-1.0374652407897 +-167.27368,53.2988349,13.719616,-881342.160671246,453363.762097105,65.5503005981445,10,1.81657468760225,-1.09709835278823 +-167.21936,53.3054462,13.719616,-877638.170166475,453363.77071206,76.6021728515625,10,1.88424108874566,-0.851314669921612 +-167.16502,53.3120306,13.719616,-873934.045559114,453363.745108791,80.5800857543945,10,1.90622772523454,-0.771452930583128 +-167.11067,53.3185881,13.719616,-870230.437491333,453363.81715826,88.872314453125,10,1.94876649040944,-0.616939993695531 +-167.05629,53.3251188,13.719616,-866526.029097106,453363.735959573,93.4953231811523,10,1.97078988715682,-0.536944730605765 +-167.0019,53.3316227,13.719616,-862822.126149592,453363.763886681,93.8844604492188,10,1.97259371474062,-0.530392713957735 +-166.94749,53.3380996,13.719616,-859118.073383772,453363.748986399,90.8984680175781,10,1.95855656378172,-0.581379652842264 +-166.89307,53.3445496,13.719616,-855414.519258096,453363.831822578,99.2588577270508,111,1.99676927302035,-0.442580185894447 +-166.83862,53.3509728,13.719616,-851710.146926981,453363.76599995,97.2523574829102,111,1.98790013780658,-0.474795416494068 +-166.78416,53.357369,13.719616,-848006.266396562,453363.787672437,98.9079818725586,111,1.99523134056918,-0.448166395526712 +-166.72968,53.3637383,13.719616,-844302.215916799,453363.779824843,91.0124816894531,10,1.95910095668517,-0.579402262431718 +-166.67518,53.3700806,13.719616,-840597.993093871,453363.732462852,94.3004455566406,111,1.9745137447239,-0.523418617027376 +-166.62067,53.376396,13.719616,-836894.246412013,453363.783416594,115.246162414551,111,2.06162647271737,-0.207000324507061 +-166.56614,53.3826844,13.719616,-833190.318340167,453363.795573602,124.026298522949,111,2.09351378268181,-0.0911765131717951 +-166.51159,53.3889458,13.719616,-829486.20434043,453363.769862383,142.652984619141,111,2.15428086249897,0.129546865375521 +-166.45702,53.3951803,13.719616,-825781.897800742,453363.718128924,154.802581787109,111,2.18977819954161,0.258483325463082 +-166.40244,53.4013877,13.719616,-822078.053437605,453363.743291932,166.632461547852,111,2.22175960990281,0.374648936298309 +-166.34784,53.4075682,13.719616,-818374.007458162,453363.743224086,146.925918579102,111,2.16709841459888,0.176103873095976 +-166.29323,53.4137216,13.719616,-814670.414535803,453363.819739926,162.723526000977,111,2.21145034626068,0.337202748193266 +-166.23859,53.4198479,13.719616,-810965.959863503,453363.727909371,169.346633911133,111,2.22877656863138,0.400136533239866 +-166.18394,53.4259472,13.719616,-807261.947052713,453363.724412431,181.696884155273,210,2.25934747983542,0.511178808539741 +-166.12928,53.4320195,13.719616,-803558.371539914,453363.808569379,186.793182373047,210,2.27136102118852,0.554815419740279 +-166.07459,53.4380647,13.719616,-799853.920541823,453363.727909219,193.311004638672,210,2.28625657786618,0.608920333208706 +-166.01989,53.4440828,13.719616,-796149.899684725,453363.724876392,211.654403686523,210,2.32562730884528,0.751926065650214 +-165.96518,53.4500738,13.719616,-792446.304367399,453363.798813969,228.893280029297,210,2.35963304261323,0.875444596898141 +-165.91045,53.4560376,13.719616,-788742.476853893,453363.81938172,252.506500244141,210,2.40227256258864,1.03032350397952 +-165.8557,53.4619744,13.719616,-785038.408565223,453363.80946521,285.302856445312,210,2.45530611982471,1.22295652114522 +-165.80093,53.4678841,13.719616,-781334.096879255,453363.759184769,341.808013916016,310,2.5337822408268,1.50800419193976 +-165.74615,53.4737666,13.719616,-777630.194246318,453363.77575671,509.700408935547,310,2.70731498202579,2.13832463915007 +-168.34439,53.1283942,13.12906687,-955422.488560207,449659.837757759,41.800895690918,10,1.62118558774287,-1.8068073330789 +-168.29048,53.1355342,13.719616,-951718.267493208,449659.793395892,62.5893325805664,10,1.79650032049206,-1.17001418392723 +-168.23655,53.1426476,13.719616,-948013.99047751,449659.733328981,71.1407165527344,10,1.85211823522889,-0.967994042669726 +-168.18261,53.1497344,13.719616,-944310.308872051,449659.800430086,73.8482131958008,10,1.86833999174557,-0.909071992850853 +-168.12864,53.1567946,13.719616,-940605.907022668,449659.710447977,64.9897994995117,10,1.81284519712417,-1.11064492670715 +-168.07466,53.1638282,13.719616,-936902.091950001,449659.747906812,58.5347633361816,10,1.76741386678368,-1.27566448589651 +-168.02066,53.1708352,13.719616,-933198.203661623,449659.771321918,63.1688003540039,10,1.80050262923593,-1.15547665619686 +-167.96664,53.1778156,13.719616,-929494.237830846,449659.781408939,68.2353668212891,10,1.8340095305824,-1.03377002668469 +-167.9126,53.1847693,13.719616,-925790.192435154,449659.768036039,71.7928009033203,10,1.85608089710142,-0.953600523692404 +-167.85854,53.1916964,13.719616,-922086.060814236,449659.742788116,73.8270797729492,10,1.86821569026215,-0.909523491317838 +-167.80447,53.1985968,13.719616,-918382.49658977,449659.833834156,78.8415069580078,10,1.89675491668925,-0.805860875028385 +-167.75037,53.2054706,13.719616,-914678.181771815,449659.775647565,80.3929061889648,10,1.90521772861278,-0.775121526595121 +-167.69626,53.2123176,13.719616,-910974.427899146,449659.823276433,74.0404891967773,10,1.86946927954007,-0.904970097250434 +-167.64212,53.2191379,13.719616,-907269.916965164,449659.713440591,58.5,10,1.76715586608218,-1.27660161808509 +-167.58797,53.2259315,13.719616,-903565.955928641,449659.720696789,65.9966430664062,10,1.81952184562045,-1.08639343366345 +-167.5338,53.2326984,13.719616,-899861.884735382,449659.708652113,70.8750228881836,10,1.85049321215084,-0.973896590316962 +-167.47962,53.2394385,13.719616,-896158.356904237,449659.802163595,57.651195526123,10,1.76080831778882,-1.29965772525723 +-167.42541,53.2461519,13.719616,-892454.05444837,449659.74245606,69.3857727050781,10,1.84127042911325,-1.00739637075386 +-167.37119,53.2528385,13.719616,-888750.286530903,449659.788783658,78.2043228149414,10,1.89323075974511,-0.818661618944033 +-167.31695,53.2594984,13.719616,-885046.390844679,449659.817891653,76.1171951293945,10,1.88148277643225,-0.861333647544639 +-167.26269,53.2661314,13.719616,-881342.367390158,449659.808843788,69.8777313232422,10,1.84433879657147,-0.99625118434635 +-167.20841,53.2727376,13.719616,-877638.209513338,449659.773342278,84.840217590332,10,1.92860177368421,-0.690184000424701 +-167.15411,53.279317,13.719616,-873933.912776229,449659.712222417,90.1253662109375,10,1.9548470424217,-0.594853693224645 +-167.0998,53.2858696,13.719616,-870230.12840672,449659.757365342,95.9764251708984,111,1.98216456975283,-0.495628636759394 +-167.04547,53.2923954,13.719616,-866526.196289524,449659.777471818,99.4072189331055,111,1.99741792392421,-0.44022410066823 +-166.99112,53.2988943,13.719616,-862822.114132995,449659.762514666,97.9018859863281,111,1.99079105815213,-0.464294768648244 +-166.93676,53.3053663,13.719616,-859118.533127013,449659.842723088,104.643920898438,111,2.01971400384577,-0.359238374458347 +-166.88237,53.3118114,13.719616,-855414.137448614,449659.759686356,105.445816040039,111,2.02302935214784,-0.347196083130605 +-166.82797,53.3182297,13.719616,-851710.231818775,449659.783352767,110.369041442871,111,2.04284727071171,-0.275211746309507 +-166.77355,53.324621,13.719616,-848006.160347694,449659.763463162,114.016136169434,111,2.05696631934899,-0.22392733168121 +-166.71911,53.3309855,13.719616,-844301.91428735,449659.722711085,110.7626953125,111,2.0443935153753,-0.26959534434917 +-166.66466,53.337323,13.719616,-840598.149044244,449659.766786881,121.297637939453,111,2.08385234381917,-0.126269616770093 +-166.61019,53.3436336,13.719616,-836894.202324264,449659.779816882,130.557067871094,111,2.11580038787345,-0.0102252018853165 +-166.5557,53.3499172,13.719616,-833190.071707917,449659.751825982,143.849670410156,111,2.1579088711675,0.14272482839639 +-166.5012,53.3561738,13.719616,-829486.408328452,449659.808648811,169.590438842773,111,2.22940136398866,0.402405968311882 +-166.44667,53.3624035,13.719616,-825781.894237738,449659.711773877,177.200805664062,111,2.24846569212587,0.471653049607211 +-166.39214,53.3686063,13.719616,-822078.491927845,449659.835190162,172.207992553711,210,2.2360533041526,0.426567713640043 +-166.33758,53.374782,13.719616,-818374.233970542,449659.785008272,183.134429931641,210,2.26277000090275,0.523610381941036 +-166.28301,53.3809307,13.719616,-814670.425085468,449659.820120847,200.278045654297,210,2.30163334483145,0.664773139792802 +-166.22842,53.3870524,13.719616,-810966.405048181,449659.817720559,218.483764648438,210,2.3394191704343,0.802022043530739 +-166.17381,53.393147,13.719616,-807262.171324198,449659.767878834,236.412185668945,210,2.37366985813303,0.926430317372087 +-166.11919,53.3992146,13.719616,-803558.372979403,449659.803504366,253.737167358398,210,2.40438408723117,1.03799316417032 +-166.06455,53.4052552,13.719616,-799854.349778511,449659.803490994,274.378967285156,310,2.4383508171583,1.16137002233559 +-166.00989,53.4112687,13.719616,-796150.099149352,449659.757932872,290.791351318359,210,2.46358148564447,1.25301501182713 +-165.95522,53.4172551,13.719616,-792446.272161958,449659.787174885,319.464782714844,210,2.50442298920612,1.40136301008876 +-165.90053,53.4232144,13.719616,-788742.208543401,449659.771806978,382.065216064453,310,2.58213750050205,1.68364429704549 +-165.84582,53.4291467,13.719616,-785037.901716797,449659.723795949,419.441040039062,310,2.62267092157641,1.83087325177778 +-165.7911,53.4350518,13.719616,-781334.006690645,449659.739988544,488.701599121094,310,2.68904376012154,2.07195834606791 +-168.38642,53.0886303,13.719616,-959126.518806635,445955.846614792,49.5867462158203,10,1.69536561168139,-1.53736431304741 +-168.33257,53.0957914,13.719616,-955422.248342879,445955.782752227,71.3723526000977,10,1.85353001235734,-0.962866065177898 +-168.2787,53.102926,13.719616,-951717.921206924,445955.710955111,76.2554092407227,10,1.88227065615094,-0.858471843523083 +-168.22482,53.1100341,13.719616,-948014.189346888,445955.774656573,88.9813613891602,10,1.94929904604315,-0.615005599627384 +-168.17092,53.1171156,13.719616,-944310.394602075,445955.819838246,101.695899963379,10,2.00730344398298,-0.404317070206434 +-168.117,53.1241705,13.719616,-940606.532658891,445955.847194653,94.0574111938477,10,1.97339302119191,-0.527489404781882 +-168.06305,53.1311988,13.719616,-936901.942972333,445955.716352614,80.8128128051758,10,1.90748022326761,-0.766903500228504 +-168.00909,53.1382006,13.719616,-933197.931352017,445955.721585764,87.70703125,10,1.94303441104759,-0.637760542036101 +-167.95512,53.1451757,13.719616,-929494.498128623,445955.840239608,87.4157333374023,10,1.94158960525083,-0.643008489078536 +-167.90112,53.1521242,13.719616,-925790.324185364,445955.803413399,78.477180480957,10,1.89474339137038,-0.813167309133003 +-167.8471,53.159046,13.719616,-922086.0637136,445955.741505282,80.042106628418,10,1.90331851031222,-0.78202002955362 +-167.79307,53.1659412,13.719616,-918382.366288539,445955.804402661,85.4277572631836,10,1.9315990049699,-0.679297200900097 +-167.73901,53.1728098,13.719616,-914677.915114113,445955.715727428,91.477668762207,10,1.96131508841602,-0.571359904009161 +-167.68494,53.1796517,13.719616,-910974.020570954,445955.741396511,82.4082717895508,10,1.91597080650606,-0.73606327845273 +-167.63085,53.1864668,13.719616,-907270.024318231,445955.733022713,82.5661315917969,10,1.91680193740332,-0.733044373805497 +-167.57674,53.1932553,13.719616,-903565.917443673,445955.713110491,80.367546081543,10,1.90508070791335,-0.775619224885042 +-167.52262,53.2000171,13.719616,-899862.35406237,445955.807078495,77.9452896118164,10,1.89178987504241,-0.823895323453694 +-167.46847,53.2067521,13.719616,-896158.019567924,445955.733292006,65.84912109375,10,1.81854998268912,-1.08992351722736 +-167.41431,53.2134604,13.719616,-892454.219771016,445955.773859936,71.0609359741211,10,1.85163092347021,-0.96976409806988 +-167.36013,53.220142,13.719616,-888750.294049411,445955.794093447,82.2600936889648,10,1.91518919980697,-0.738902297076591 +-167.30593,53.2267968,13.719616,-885046.240213512,445955.783933837,80.5735549926758,10,1.90619252561056,-0.771580785664396 +-167.25171,53.2334248,13.719616,-881342.053834317,445955.744202979,90.217643737793,10,1.95529148020974,-0.593239368323332 +-167.19748,53.240026,13.719616,-877638.386706422,445955.807884068,95.8866653442383,10,1.98175821540761,-0.497104631726311 +-167.14322,53.2466005,13.719616,-873933.919755864,445955.721837493,96.4465866088867,111,1.98428686191088,-0.487919865878881 +-167.08895,53.2531481,13.719616,-870229.965370826,445955.728894289,103.915954589844,111,2.0166822314685,-0.370250637086558 +-167.03467,53.2596689,13.719616,-866526.516915752,445955.839120197,106.466186523438,111,2.02721169849772,-0.332004607427338 +-166.98036,53.2661628,13.719616,-862822.259643603,445955.780976546,110.158622741699,111,2.04201849751558,-0.278222087113276 +-166.92604,53.27263,13.719616,-859118.497236913,445955.837515703,111.480461120605,111,2.04719875643273,-0.259405908133077 +-166.87169,53.2790702,13.719616,-855413.919226134,445955.717664249,112.46378326416,111,2.05101268901788,-0.245552616379069 +-166.81734,53.2854836,13.719616,-851710.485522615,445955.83051176,116.371559143066,111,2.06584685302466,-0.191670698614494 +-166.76296,53.2918701,13.719616,-848006.225101334,445955.779646306,127.472595214844,111,2.10541682770149,-0.0479412561930412 +-166.70857,53.2982297,13.719616,-844302.445923735,445955.821912734,153.092346191406,111,2.18495347881108,0.240958562657395 +-166.65416,53.3045624,13.719616,-840598.487265263,445955.829977914,165.114974975586,111,2.21778646305285,0.360217332890205 +-166.59973,53.3108682,13.719616,-836894.344625075,445955.804766136,165.437118530273,111,2.21863295723771,0.363292041383137 +-166.54528,53.317147,13.719616,-833190.01558329,445955.736306892,175.926467895508,111,2.24533118338145,0.460267619169625 +-166.49082,53.3233989,13.719616,-829486.149756652,445955.761344825,195.046646118164,210,2.29013848689648,0.623020534813895 +-166.43634,53.3296239,13.719616,-825782.086405841,445955.754814388,221.139739990234,210,2.34466679462585,0.821082912415527 +-166.38185,53.3358219,13.719616,-822078.479300632,445955.830553475,238.017425537109,210,2.3766087534329,0.937105223945446 +-166.32733,53.3419929,13.719616,-818374.011440198,445955.74139636,254.131896972656,210,2.40505917827284,1.04044528752382 +-166.2728,53.3481369,13.719616,-814669.990729788,445955.735331967,275.254913330078,310,2.43973507991662,1.16639805978174 +-166.21826,53.3542539,13.719616,-810966.412616154,445955.811670326,293.819915771484,310,2.46808122990392,1.26935936733234 +-166.16369,53.3603439,13.719616,-807261.960087568,445955.72661997,314.701629638672,310,2.49789899185269,1.37766598956684 +-166.10911,53.3664069,13.719616,-803557.941038417,445955.724851269,338.172180175781,310,2.5291378773803,1.49113453826878 +-166.05452,53.3724429,13.719616,-799854.350904647,445955.805702148,369.824188232422,310,2.5679953126434,1.63227583416059 +-165.99991,53.3784518,13.719616,-796150.53088643,445955.837715858,406.427337646484,310,2.6089829123411,1.78115449528831 +-165.94528,53.3844336,13.719616,-792446.476385683,445955.821916953,470.648162841797,410,2.67269636777444,2.01257995105291 +-165.89063,53.3903884,13.719616,-788742.180823418,445955.770264828,614.844177246094,410,2.78876506449609,2.43417458685029 +-165.83597,53.3963161,13.719616,-785038.29781711,445955.791089964,578.695617675781,410,2.76245019356722,2.3385914646247 +-165.78129,53.4022167,13.719616,-781334.166530569,445955.766120769,664.527526855469,410,2.82251297551777,2.55675663229385 +-168.42836,53.0488474,13.31683768,-962830.09283688,442251.756150922,28.1141986846924,10,1.44892570969227,-2.43250437802294 +-168.37458,53.0560296,13.719616,-959126.434803582,442251.822986999,67.8544158935547,10,1.8315781163406,-1.0426016172056 +-168.32077,53.0631854,13.719616,-955422.062570988,442251.744671133,70.3304824829102,10,1.84714359678134,-0.98606334941441 +-168.26695,53.0703146,13.719616,-951718.290192518,442251.788494458,93.0162048339844,10,1.96855861583253,-0.545049344923818 +-168.21311,53.0774174,13.719616,-948014.451865034,442251.832403147,97.7109832763672,10,1.98994338365964,-0.467373764355326 +-168.15924,53.0844936,13.719616,-944309.891243485,442251.713217633,104.558059692383,10,2.01935751534611,-0.360533242441042 +-168.10536,53.0915432,13.719616,-940605.917585789,442251.716578202,103.480834960938,111,2.01485992427204,-0.376869776962379 +-168.05147,53.0985662,13.719616,-936902.526575549,442251.841519333,79.2069396972656,10,1.89876323386468,-0.798566093816428 +-167.99755,53.1055627,13.719616,-933198.398000399,442251.816898514,97.8567123413086,10,1.99059062082498,-0.465022814230961 +-167.94361,53.1125326,13.719616,-929494.186660433,442251.774227064,92.0044174194336,10,1.96380867968064,-0.562302468794243 +-167.88965,53.1194758,13.719616,-925789.8905315,442251.703382817,79.7368545532227,10,1.90165909968451,-0.788047482596397 +-167.83568,53.1263925,13.719616,-922086.157449637,442251.765662076,83.2124481201172,10,1.92018829919327,-0.720744141220518 +-167.78169,53.1332825,13.719616,-918382.330892976,442251.800141594,99.8463745117188,10,1.99933229997146,-0.433270540447279 +-167.72768,53.1401459,13.719616,-914678.404217429,442251.818436175,95.2717742919922,10,1.97896425336755,-0.507253099332002 +-167.67365,53.1469826,13.719616,-910974.375348019,442251.810450166,81.642692565918,111,1.9119173192586,-0.750786701115941 +-167.6196,53.1537927,13.719616,-907270.23765047,442251.787819726,98.216682434082,10,1.99218526043186,-0.459230628023294 +-167.56553,53.160576,13.719616,-903565.991275673,442251.729595175,94.8759002685547,10,1.97715590990286,-0.513821518948363 +-167.51145,53.1673327,13.719616,-899862.284115518,442251.793796457,85.5932846069336,10,1.93243969256783,-0.676243583588291 +-167.45735,53.1740626,13.719616,-896158.459492711,442251.822869185,89.8442993164062,10,1.95349052603074,-0.599780947944961 +-167.40323,53.1807659,13.719616,-892454.508541552,442251.839359847,91.2123870849609,10,1.96005382163256,-0.575941184968055 +-167.34909,53.1874424,13.719616,-888750.431326917,442251.822338126,91.4810791015625,10,1.96133127885874,-0.571301095699991 +-167.29493,53.1940922,13.719616,-885046.221217877,442251.783498703,91.4867095947266,10,1.96135800806752,-0.571204007584416 +-167.24076,53.2007152,13.719616,-881342.532796699,442251.845504697,100.599998474121,111,2.00259797413262,-0.421408679777736 +-167.18656,53.2073114,13.719616,-877638.048061567,442251.743213162,95.3088073730469,111,1.97913303512707,-0.506640035806297 +-167.13235,53.2138809,13.719616,-873934.073966971,442251.753213835,101.793029785156,111,2.00771804097243,-0.402811135603 +-167.07812,53.2204235,13.719616,-870229.953658583,442251.721885433,112.489715576172,111,2.05111281869017,-0.245188916829461 +-167.02388,53.2269394,13.719616,-866526.335126486,442251.802337012,109.08056640625,111,2.03774738437108,-0.293735989151151 +-166.96961,53.2334284,13.719616,-862821.90468818,442251.712151587,120.694549560547,111,2.08168765825621,-0.134132372597549 +-166.91533,53.2398906,13.719616,-859117.969291926,442251.72349461,140.604125976562,111,2.14799806508325,0.1067259518727 +-166.86104,53.246326,13.719616,-855414.524483565,442251.835581741,148.23030090332,111,2.17093699021549,0.19004667537409 +-166.80672,53.2527345,13.719616,-851710.254362185,442251.78024674,148.201553344727,111,2.17085275563729,0.189740711343105 +-166.75239,53.2591162,13.719616,-848006.465891444,442251.826341383,168.862686157227,111,2.22753369346487,0.395622055883229 +-166.69804,53.265471,13.719616,-844302.499930388,442251.835077535,186.564056396484,210,2.27082797589334,0.552879247081907 +-166.64367,53.2717989,13.719616,-840598.351983327,442251.807374617,196.587448120117,210,2.29355578518384,0.635433137587633 +-166.58928,53.2780999,13.719616,-836894.017550864,442251.744161196,218.697326660156,210,2.33984347428666,0.803563236230897 +-166.53488,53.2843739,13.719616,-833190.150997901,442251.760930908,251.718170166016,210,2.40091456603711,1.02539087289355 +-166.48046,53.2906211,13.719616,-829486.086857981,442251.753860896,271.722045898438,310,2.43412487589903,1.1460201974782 +-166.42603,53.2968413,13.719616,-825782.481562566,442251.826442219,293.611511230469,310,2.46777307837575,1.26824007302681 +-166.37157,53.3030346,13.719616,-822078.014944436,442251.741297709,311.167266845703,310,2.4929939052329,1.35984931491266 +-166.3171,53.3092009,13.719616,-818373.998103366,442251.736621318,334.942504882812,310,2.52497026388722,1.47599657650657 +-166.26262,53.3153402,13.719616,-814670.426491247,442251.811718008,349.704071044922,310,2.54370068813439,1.54403082356765 +-166.20811,53.3214526,13.719616,-810965.979956737,442251.732590159,373.910949707031,310,2.57276818333478,1.6496122628246 +-166.15359,53.327538,13.719616,-807261.969561973,442251.734107628,411.405639648438,310,2.61427024081376,1.8003595814548 +-166.09906,53.3335963,13.719616,-803558.39275941,442251.804685179,450.105163574219,410,2.65331399516227,1.94217764144557 +-166.0445,53.3396277,13.719616,-799853.927384452,442251.724619303,502.362823486328,410,2.70101749268746,2.11545036039084 +-165.98993,53.345632,13.719616,-796149.886455172,442251.714534438,546.421752929688,410,2.73752798018534,2.24806687211378 +-165.93535,53.3516093,12.45739295,-792446.263390521,442251.784709345,625.674438476562,410,2.79634841252053,2.46171947137806 +-169.86014,52.8125087,10.97126037,-1062838.24765105,438547.781244282,19.354528427124,111,1.28678259420352,-3.02145445373082 +-168.63128,52.9872766,8.271401525,-977645.980817282,438547.724025126,31.3846664428711,10,1.49671751731713,-2.25891089158946 +-168.57762,52.9945593,13.719616,-973942.421113247,438547.820568115,56.3641052246094,10,1.75100261700414,-1.33527482933283 +-168.52393,53.0018156,13.719616,-970238.161012305,438547.764658507,62.1596450805664,10,1.79350852606326,-1.18088123523578 +-168.47023,53.0090454,13.719616,-966534.513367821,438547.838870295,34.0535507202148,10,1.53216240194041,-2.13016495366043 +-168.4165,53.0162488,13.719616,-962830.156843248,438547.763063578,60.3715019226074,10,1.78083198036874,-1.22692606744464 +-168.36276,53.0234257,13.719616,-959126.404266473,438547.817593948,88.9784698486328,10,1.94928493296958,-0.615056862338861 +-168.30899,53.0305761,13.719616,-955421.936682621,438547.713734373,89.1742553710938,10,1.95023949155034,-0.611589633115386 +-168.25521,53.0377,13.719616,-951718.064504443,438547.740456984,98.9902877807617,10,1.99559258681842,-0.446854246039529 +-168.20141,53.0447974,13.719616,-948014.126111989,438547.754032031,117.974617004395,111,2.07178857611333,-0.170088664419838 +-168.14759,53.0518683,13.719616,-944310.117224242,438547.755160921,111.776588439941,111,2.04835085027614,-0.255221174453475 +-168.09375,53.0589126,13.719616,-940606.035893424,438547.733706309,110.53971862793,111,2.04351835477721,-0.272774177437137 +-168.0399,53.0659304,13.719616,-936902.53281881,438547.842305933,100.381454467773,10,2.00165348406124,-0.424839337301315 +-167.98602,53.0729217,13.719616,-933198.289021733,438547.798976417,84.0746917724609,10,1.92466528381582,-0.704482455212793 +-167.93212,53.0798863,13.719616,-929493.962170059,438547.724380617,111.799873352051,111,2.0484413115778,-0.254892593185614 +-167.87821,53.0868243,13.719616,-925790.202951243,438547.769508691,107.356925964355,111,2.03083006750607,-0.318861658403654 +-167.82428,53.0937358,13.719616,-922086.347398111,438547.805445962,109.595962524414,111,2.03979455519155,-0.28630008041049 +-167.77033,53.1006206,13.719616,-918382.395771192,438547.81123496,108.197860717773,111,2.03421867400853,-0.306553272382157 +-167.71636,53.1074788,13.719616,-914678.341429636,438547.798494724,107.184852600098,111,2.03013341504888,-0.321392098972597 +-167.66237,53.1143104,13.719616,-910974.180030791,438547.767997685,104.017845153809,111,2.01710785263528,-0.368704659524448 +-167.60836,53.1211153,13.719616,-907269.909486249,438547.709659663,105.294189453125,111,2.0224044057717,-0.349466066746177 +-167.55434,53.1278936,13.719616,-903566.180512829,438547.771188276,104.329467773438,111,2.01840699187695,-0.363985814987434 +-167.5003,53.1346452,13.719616,-899862.333653861,438547.805340791,95.5001831054688,10,1.98000420427085,-0.503475700819659 +-167.44624,53.1413701,13.719616,-896158.36452483,438547.812918495,97.7449264526367,111,1.99009422416706,-0.46682586857823 +-167.39216,53.1480682,13.719616,-892454.270960201,438547.783858408,102.083106994629,111,2.0089538797361,-0.398322216469838 +-167.33806,53.1547397,13.719616,-888750.044113293,438547.74072361,100.938774108887,111,2.00405802596752,-0.416105354773104 +-167.28395,53.1613845,13.719616,-885046.339162647,438547.806738563,108.679527282715,111,2.03614774072345,-0.299546351463102 +-167.22982,53.1680025,13.719616,-881342.496561864,438547.837477503,109.696098327637,111,2.04019118085719,-0.284859422784627 +-167.17567,53.1745937,13.719616,-877638.511880803,438547.83378001,112.119293212891,111,2.04968035135449,-0.250392047059531 +-167.1215,53.1811582,13.719616,-873934.37850688,438547.807377259,114.299743652344,111,2.05804525637518,-0.220008324442783 +-167.06731,53.1876959,13.719616,-870230.09419869,438547.748247762,117.462173461914,111,2.0698980325514,-0.176955658251607 +-167.01311,53.1942069,13.719616,-866526.309696718,438547.798623533,130.565505981445,111,2.11582845610754,-0.0101232500476273 +-166.95889,53.200691,13.719616,-862822.367543477,438547.806013987,147.451217651367,111,2.16864836330414,0.181733729192877 +-166.90465,53.2071483,13.719616,-859118.261120172,438547.782187936,154.483016967773,111,2.18888074238489,0.255223504910113 +-166.85039,53.2135788,13.719616,-855413.985974035,438547.728038578,175.82731628418,111,2.24508634735837,0.459378304850616 +-166.79612,53.2199825,13.719616,-851710.19499149,438547.772716332,201.890441894531,210,2.30511575861317,0.677422260627866 +-166.74183,53.2263593,13.719616,-848006.228485985,438547.776872759,224.299468994141,210,2.35082824543679,0.843463060414004 +-166.68752,53.2327093,13.719616,-844302.079859301,438547.752320262,240.247756958008,210,2.38065934162546,0.951818116413822 +-166.6332,53.2390324,13.719616,-840598.404085531,438547.815663546,268.653991699219,210,2.42919329776183,1.12810729807137 +-166.57885,53.2453286,13.719616,-836893.881980914,438547.714127619,299.797271728516,310,2.47682767628197,1.30112895706174 +-166.5245,53.2515979,13.719616,-833190.481072543,438547.82670631,323.768585205078,310,2.51023470749964,1.42247282976036 +-166.47012,53.2578403,13.719616,-829486.224826407,438547.776298757,346.805603027344,310,2.54008610536761,1.53090162725407 +-166.41573,53.2640558,13.719616,-825782.423419359,438547.814226584,369.263092041016,310,2.56733590195386,1.62988066632161 +-166.36132,53.2702444,13.719616,-822078.41499591,438547.815999585,393.568145751953,310,2.59501994066382,1.73043699672752 +-166.30689,53.276406,13.719616,-818374.197085173,438547.771685801,443.467712402344,310,2.6468620055974,1.91874217376483 +-166.25245,53.2825407,13.719616,-814670.420447048,438547.815850783,471.531280517578,410,2.67351050832587,2.01553714191456 +-166.19799,53.2886484,13.719616,-810966.425242677,438547.814791047,504.788482666016,410,2.70310943741742,2.12304890075054 +-166.14351,53.2947292,13.719616,-807262.204899682,438547.780423352,548.738952636719,410,2.73936579000242,2.25474232193257 +-166.08902,53.3007829,13.719616,-803558.416249608,438547.812925524,603.51611328125,410,2.7806888698198,2.40483954261055 +-169.95347,52.7642176,13.719616,-1070246.4040181,434843.820162202,192.856552124023,111,2.28523439820839,0.605207484932479 +-169.90034,52.772151,13.719616,-1066541.99401481,434843.723005672,126.257293701172,111,2.10125647607922,-0.063052840767695 +-169.8472,52.7800583,13.719616,-1062838.29209268,434843.79647973,113.63599395752,111,2.05551591501209,-0.229195614219429 +-169.79403,52.7879395,13.719616,-1059133.97840122,434843.720428536,100.175086975098,111,2.00075972817275,-0.428085713791619 +-169.68764,52.8036236,8.825220889,-1051726.13109507,434843.761868924,65.7313461303711,111,1.81777252640795,-1.09274746034869 +-168.72647,52.9400627,11.58100037,-985054.234259079,434843.784481639,22.552755355835,10,1.3531996088629,-2.78020889918464 +-168.67288,52.9473928,12.93161128,-981350.0178339,434843.738486307,50.1199150085449,10,1.70001032586259,-1.52049338540788 +-168.61928,52.9546964,13.719616,-977646.424482384,434843.819912312,68.9924926757812,10,1.83880183614504,-1.01636300502099 +-168.56565,52.9619737,13.719616,-973942.129327851,434843.75607485,79.1387405395508,10,1.89838913436726,-0.799924929969676 +-168.51201,52.9692246,13.71911652,-970238.446377003,434843.830668383,76.9608840942383,10,1.8862700480506,-0.843944910603432 +-168.45834,52.976449,11.77385584,-966534.057995116,434843.740772694,36.3263664245605,10,1.56022195936333,-2.02824463210534 +-168.40466,52.983647,13.54481901,-962830.273335937,434843.789520402,73.8711929321289,10,1.86847511241827,-0.908581196000328 +-168.35096,52.9908185,13.719616,-959126.432639927,434843.820657485,147.407806396484,111,2.16852048342225,0.18126923296131 +-168.29724,52.9979636,13.719616,-955422.529269008,434843.845703404,78.3800888061523,10,1.89420575120639,-0.815120171666411 +-168.24349,53.0050822,13.719616,-951717.903438224,434843.711205432,92.130744934082,10,1.96440458271655,-0.560137978880163 +-168.18974,53.0121743,13.719616,-948014.524573621,434843.847782695,101.221282958984,10,2.00527183760107,-0.411696444463737 +-168.13596,53.0192399,13.719616,-944310.414693403,434843.82621957,101.390884399414,111,2.00599891127947,-0.409055505336292 +-168.08216,53.0262789,13.719616,-940606.229749559,434843.779690746,115.11498260498,111,2.06113185220672,-0.208796927380487 +-168.02834,53.0332914,13.719616,-936901.963101669,434843.719762043,123.332824707031,10,2.09107867831448,-0.100021507281929 +-167.97451,53.0402774,13.719616,-933198.268358708,434843.787683356,118.347030639648,10,2.07315736583085,-0.165116829474308 +-167.92066,53.0472368,13.719616,-929494.485633266,434843.831707684,116.346168518066,10,2.06575208578467,-0.192014920279391 +-167.86678,53.0541697,13.719616,-925789.950398807,434843.724029429,116.935829162598,111,2.06794759947243,-0.184040187903471 +-167.81289,53.0610759,13.719616,-922085.978735819,434843.723055393,107.208877563477,111,2.03023074913658,-0.321038553784156 +-167.75898,53.0679556,13.719616,-918381.90381864,434843.711296488,105.163681030273,111,2.02186577925209,-0.351422512004716 +-167.70506,53.0748087,13.719616,-914678.381510481,434843.816395739,106.366401672363,111,2.0268044675023,-0.333483786637999 +-167.65111,53.0816351,13.719616,-910974.093933581,434843.752249677,104.192489624023,111,2.01783641538965,-0.366058311648061 +-167.59715,53.0884349,13.719616,-907270.350261447,434843.805404759,102.228324890137,111,2.0095712445182,-0.396079771367801 +-167.54317,53.0952081,13.719616,-903566.488244299,434843.838925419,98.758171081543,111,1.99457303856499,-0.450557536304027 +-167.48917,53.1019546,13.719616,-899862.505767698,434843.842745662,103.891525268555,111,2.01658012234819,-0.370621526556378 +-167.43515,53.1086744,13.719616,-896158.398448414,434843.817671242,110.140953063965,111,2.04194883016805,-0.278475138804523 +-167.38111,53.1153675,13.719616,-892454.161899375,434843.764516705,115.194091796875,111,2.06143020507838,-0.207713224592222 +-167.32706,53.122034,13.719616,-888750.447418264,434843.828805731,120.827674865723,111,2.08216641826624,-0.132393379589403 +-167.27298,53.1286737,13.719616,-885045.939242038,434843.721413853,114.606857299805,111,2.05921060365554,-0.21577545049729 +-167.21889,53.1352867,13.719616,-881341.946552589,434843.721148333,130.254867553711,111,2.11479396162391,-0.0138808292863208 +-167.16479,53.141873,13.719616,-877638.464947622,434843.8271857,142.472930908203,111,2.1537323585627,0.127554542520352 +-167.11066,53.1484325,13.719616,-873934.176396494,434843.764639526,153.587677001953,111,2.18635637178439,0.246054270361976 +-167.05652,53.1549653,13.719616,-870230.390096254,434843.809003,169.884094238281,111,2.23015271902259,0.405135104253179 +-167.00236,53.1614713,13.719616,-866526.445891687,434843.818113813,183.217391967773,111,2.26296669682706,0.524324837680741 +-166.94818,53.1679506,13.719616,-862822.337188734,434843.803739648,192.96598815918,111,2.28548076778249,0.606102369546497 +-166.89398,53.174403,13.719616,-859118.063848957,434843.744994724,221.790069580078,210,2.34594209716426,0.825715175242597 +-166.83977,53.1808287,13.719616,-855414.275030157,434843.793360588,240.20182800293,210,2.38057630818164,0.951516515245761 +-166.78554,53.1872275,13.719616,-851710.312650359,434843.798040419,263.76953125,210,2.42122462754764,1.0991628133685 +-166.73129,53.1935995,13.719616,-848006.170109455,434843.77083966,289.071411132812,310,2.46100514251394,1.24365699821551 +-166.67703,53.1999446,13.719616,-844302.502951417,434843.8289182,355.25830078125,310,2.55054423421774,1.56888853628488 +-166.62274,53.2062629,13.719616,-840597.988785205,434843.729279961,528.849243164062,310,2.72333188717109,2.19650261031768 +-166.56844,53.2125544,13.719616,-836893.938942266,434843.726575393,398.664031982422,310,2.60060705478404,1.75073098993332 +-166.51413,53.2188189,13.719616,-833190.353107409,434843.798277058,412.752227783203,310,2.61568942599623,1.80551446711331 +-166.45979,53.2250566,13.719616,-829485.906808312,434843.715667435,438.248382568359,310,2.64172032192971,1.90006611110112 +-166.40544,53.2312674,13.719616,-825781.913426842,434843.719171197,539.337280273438,410,2.73186044079151,2.22748075135862 +-166.35108,53.2374513,13.719616,-822078.368451893,434843.8080887,546.453491210938,410,2.73755320494999,2.24815849565887 +-166.29669,53.2436082,13.719616,-818373.953610976,434843.724362084,552.300231933594,410,2.74217522560184,2.26494699392242 +-166.24229,53.2497383,13.719616,-814669.976091049,434843.737816791,584.3349609375,410,2.76666187105786,2.35388947940312 +-166.18788,53.2558413,13.719616,-810966.437474047,434843.815044824,630.223510742188,410,2.79949460067095,2.47314732475192 +-169.99353,52.7238218,8.561767294,-1073950.19133854,431139.777747672,260.379272460938,210,2.41560640918139,1.07875584066309 +-169.94047,52.7317753,13.719616,-1070246.39684559,431139.819574918,232.762329101562,210,2.36691269424613,0.901886369448302 +-169.88738,52.7397028,13.719616,-1066541.99272843,431139.71800524,187.489776611328,111,2.27297759162462,0.560687264979334 +-169.83428,52.7476043,13.719616,-1062838.29188538,431139.795275082,186.062515258789,111,2.26965888760683,0.548632784734292 +-169.78115,52.7554797,13.719616,-1059133.97598755,431139.720462097,155.687744140625,111,2.19225442591691,0.267477686443547 +-169.72801,52.763329,12.47677385,-1055430.35789918,431139.813580437,94.2640838623047,111,1.97434625104471,-0.524027001877648 +-169.67484,52.7711522,13.35751644,-1051726.11664676,431139.756725586,149.65202331543,111,2.17508259293556,0.205104687726173 +-169.62165,52.7789492,13.719616,-1048021.90921249,431139.699103084,176.119705200195,111,2.24580794983975,0.461999371028853 +-169.56845,52.7867202,13.39333939,-1044318.38481164,431139.820047623,188.859741210938,111,2.27613939024933,0.572171820051472 +-169.51522,52.794465,9.069965724,-1040614.22761905,431139.783452659,244.585510253906,111,2.38843072496859,0.98004599888969 +-168.87492,52.8853581,12.49922189,-996166.186148444,431139.767216951,41.8489379882812,10,1.62168444126162,-1.80499535471183 +-168.82143,52.8927618,13.719616,-992462.000290281,431139.729620208,51.9174575805664,10,1.71531341673211,-1.46490819143279 +-168.76793,52.9001391,11.27085345,-988758.445600147,431139.827600517,48.6301116943359,10,1.6869052670631,-1.56809469952382 +-168.7144,52.9074901,13.719616,-985054.198514948,431139.774278017,83.1912231445312,10,1.92007750969259,-0.721146560309465 +-168.66085,52.9148147,13.719616,-981349.915735604,431139.708910917,91.6047821044922,10,1.96191814601919,-0.56916942666467 +-168.60729,52.922113,13.719616,-977646.249083492,431139.790178274,80.2468795776367,10,1.90442815374281,-0.777989487889953 +-168.5537,52.9293848,13.719616,-973941.882270613,431139.702099647,82.5755157470703,10,1.91685129487217,-0.73286509339062 +-168.5001,52.9366303,13.719616,-970238.123157035,431139.760852348,94.6487274169922,10,1.97611477910813,-0.517603203163144 +-168.44648,52.9438493,13.719616,-966534.313870305,431139.798233225,82.6113204956055,10,1.91703956417149,-0.732181245558076 +-168.39284,52.9510419,13.719616,-962830.447766081,431139.825745218,84.9973220825195,10,1.92940524308952,-0.687265570211617 +-168.33918,52.9582081,13.719616,-959126.520607699,431139.844071496,105.086128234863,111,2.02154539130265,-0.352586252484909 +-168.2855,52.9653478,13.719616,-955422.530522614,431139.843065058,106.268974304199,10,2.02640648883909,-0.334929358737191 +-168.2318,52.9724611,13.719616,-951718.470880698,431139.834260155,105.471885681152,10,2.02313671062222,-0.346806126508495 +-168.17808,52.9795479,13.719616,-948014.339784021,431139.807522464,102.536529541016,10,2.01087861418988,-0.391331031559797 +-168.12434,52.9866082,13.719616,-944310.132953881,431139.763562543,126.095405578613,111,2.10069926287597,-0.0650767981663938 +-168.07059,52.993642,13.719616,-940606.504566023,431139.844733362,121.23876953125,111,2.08364152000423,-0.127035389041084 +-168.01681,53.0006492,13.719616,-936902.135741461,431139.757087955,116.141334533691,111,2.06498681203042,-0.194794612985708 +-167.96302,53.00763,13.719616,-933198.334448988,431139.805767929,114.654960632324,111,2.05939284954689,-0.215113481401745 +-167.90921,53.0145842,13.719616,-929494.442575763,431139.828184341,111.506156921387,111,2.04729884804033,-0.259042346845277 +-167.85538,53.0215118,13.719616,-925790.455797186,431139.825084144,103.879188537598,111,2.01652854843686,-0.370808857722997 +-167.80153,53.0284129,13.719616,-922086.367495441,431139.808079637,103.751502990723,111,2.015994396814,-0.372749048879254 +-167.74766,53.0352874,13.719616,-918382.175644967,431139.767082188,100.599998474121,111,2.00259797413262,-0.421408679777736 +-167.69378,53.0421353,13.719616,-914678.534367858,431139.840594374,102.720390319824,111,2.01165666097228,-0.388504943569452 +-167.63987,53.0489566,13.719616,-910974.122407194,431139.753380149,102.193489074707,111,2.00942322702176,-0.396617413163263 +-167.58595,53.0557513,13.719616,-907270.252335724,431139.781131443,103.266258239746,111,2.01395844103495,-0.380144221388426 +-167.53201,53.0625194,13.719616,-903566.261347198,431139.786917119,109.324165344238,111,2.0387161703272,-0.290217082039464 +-167.47805,53.0692608,13.719616,-899862.147326476,431139.760675917,111.792579650879,111,2.04841297775768,-0.254995509707598 +-167.42407,53.0759756,13.719616,-896157.903663872,431139.714088603,110.971839904785,111,2.0452127866647,-0.266619517182776 +-167.37008,53.0826637,13.719616,-892454.186677375,431139.771490822,117.674911499023,111,2.07068388035446,-0.174101234727619 +-167.31607,53.0893251,13.719616,-888750.333519016,431139.798211446,126.340774536133,111,2.10154353502263,-0.0620101607504394 +-167.26204,53.0959599,13.719616,-885046.3375941,431139.805963322,144.031372070312,111,2.15845709788057,0.144716144297749 +-167.20799,53.1025679,13.719616,-881342.19891688,431139.773840934,172.27571105957,111,2.23622405111966,0.427187915360431 +-167.15392,53.1091492,13.719616,-877637.910876265,431139.713572846,181.838134765625,111,2.25968496789316,0.512404661494136 +-167.09984,53.1157038,13.719616,-873934.127525901,431139.757616675,197.545364379883,210,2.29566684293744,0.643101101904596 +-167.04574,53.1222317,13.719616,-870230.185998914,431139.774134084,218.523040771484,210,2.33949723513876,0.802305596819217 +-166.99162,53.1287328,13.719616,-866526.084040206,431139.753119837,237.400726318359,210,2.37548204332781,0.933012691248687 +-166.93749,53.1352071,13.719616,-862822.475665649,431139.825379316,261.617492675781,210,2.41766677909634,1.08623969228233 +-166.88333,53.1416547,13.719616,-859118.037372801,431139.742294318,287.282531738281,310,2.45830921944717,1.23386463614396 +-166.82916,53.1480755,13.719616,-855414.083785595,431139.753165959,311.554718017578,310,2.49353433236332,1.36181230050362 +-166.77497,53.1544695,13.719616,-851709.951991966,431139.728983519,336.493041992188,310,2.52697608830549,1.48328230331304 +-166.72077,53.1608367,12.66855084,-848006.295992926,431139.798357242,613.580078125,410,2.78787125038545,2.43092799888051 +-166.61231,53.1734905,13.719616,-840598.422345686,431139.813281422,653.174377441406,410,2.81502914000513,2.52957320561262 +-166.55805,53.1797772,13.71175713,-836894.193642607,431139.771609896,495.011993408203,410,2.69461572137378,2.09219729973209 +-166.34086,53.2046553,13.719616,-822078.535223334,431139.842351948,639.270080566406,410,2.80568437884497,2.49563036581854 +-166.28651,53.2108075,13.719616,-818373.927592795,431139.718877927,664.158386230469,410,2.82227166078864,2.55588010831956 +-169.98051,52.6913817,11.94248625,-1073950.12411815,427435.753514218,302.458129882812,210,2.48066526256065,1.3150681657821 +-169.92749,52.6993294,13.719616,-1070246.34012177,427435.804063525,250.646057128906,210,2.39906087718914,1.01865774590225 +-169.87444,52.7072511,13.719616,-1066541.94321753,427435.708646838,219.013854980469,210,2.3404715895033,0.805844729979648 +-169.82138,52.7151468,13.719616,-1062838.24742007,427435.789505417,147.383636474609,111,2.168449267897,0.181010557846661 +-169.76829,52.7230163,13.719616,-1059133.93589188,427435.704943961,111.72583770752,111,2.04815361963483,-0.255937572437957 +-169.71519,52.7308599,13.719616,-1055430.31478871,427435.807315369,149.768920898438,111,2.17542170066204,0.206336423779756 +-169.66206,52.7386773,13.719616,-1051726.06984726,427435.746386052,159.469741821289,111,2.20267829111316,0.305340140103663 +-169.60892,52.7464686,13.719616,-1048022.51243144,427435.850737593,200.398696899414,111,2.30189489318706,0.665723158073706 +-169.55575,52.7542338,13.719616,-1044318.32044484,427435.804716835,180.80615234375,111,2.25721320425595,0.503426510452189 +-169.50256,52.7619729,13.719616,-1040614.14883521,427435.767219151,197.885437011719,111,2.29641383433692,0.645814387880071 +-169.44935,52.7696858,13.719616,-1036909.99608679,427435.727990273,271.036163330078,111,2.43302724101053,1.14203327426698 +-169.39613,52.7773726,10.82488003,-1033206.51456517,427435.853939491,98.6921157836914,111,1.99428245957538,-0.451613002133787 +-169.07634,52.8229431,10.47799139,-1010982.41289062,427435.82043343,12.1745100021362,10,1.08545149081885,-3.75274648684205 +-169.02297,52.8304464,13.20488177,-1007278.26304941,427435.786298464,26.173755645752,10,1.41786604358757,-2.54532195062653 +-168.96958,52.8379235,13.719616,-1003574.09499934,427435.755563404,42.8547592163086,10,1.6319990593189,-1.7675297178427 +-168.91617,52.8453742,13.719616,-999869.909541778,427435.707212266,48.0073394775391,10,1.68130763843656,-1.58842688441767 +-168.86275,52.8527987,13.719616,-996166.356574179,427435.813480939,65.0852737426758,10,1.81348273579139,-1.10832920429618 +-168.8093,52.8601968,13.719616,-992462.118822915,427435.752803235,86.3327484130859,10,1.93617556694657,-0.662673821519993 +-168.75584,52.8675687,13.719616,-988758.50522811,427435.846882233,93.8546676635742,10,1.97245587621283,-0.530893382833729 +-168.70235,52.8749142,13.719616,-985054.198473399,427435.776390429,92.0247802734375,10,1.96390478915975,-0.561953371733733 +-168.64885,52.8822333,13.719616,-981350.512379481,427435.839177426,96.7080307006836,10,1.98546253968981,-0.48364946861395 +-168.59532,52.8895262,13.719616,-977646.119861999,427435.761445155,92.7165603637695,10,1.9671573116231,-0.550139281784502 +-168.54178,52.8967926,13.719616,-973942.342014505,427435.806357634,95.0414962768555,10,1.97791326496526,-0.511070589191064 +-168.48822,52.9040327,13.719616,-970238.51076945,427435.848462262,91.1956787109375,10,1.95997425985849,-0.57623017604069 +-168.43463,52.9112463,13.719616,-966533.967693572,427435.721234151,98.6935882568359,10,1.99428893914253,-0.451589466496462 +-168.38103,52.9184336,13.719616,-962830.021794507,427435.73864882,95.8309707641602,10,1.98150588755744,-0.498021158499698 +-168.32741,52.9255944,13.719616,-959126.014596205,427435.733631944,99.4673690795898,111,1.99768063096749,-0.439269873702974 +-168.27377,52.9327288,13.719616,-955421.939466986,427435.717711694,104.52384185791,10,2.01921536419179,-0.361049576007526 +-168.22012,52.9398367,13.719616,-951718.4535368,427435.824059406,114.96102142334,10,2.06055061382963,-0.210908151068027 +-168.16644,52.9469182,13.719616,-948014.23215124,427435.777052005,147.701416015625,111,2.16938465891943,0.184408165027306 +-168.11274,52.9539733,13.719616,-944309.930075089,427435.721275683,116.721710205078,111,2.06715164220948,-0.186931331871325 +-168.05903,52.9610018,13.719616,-940606.206731392,427435.777401178,117.485298156738,111,2.06998352338321,-0.176645131148957 +-168.0053,52.9680038,13.719616,-936902.396470049,427435.814253435,118.912139892578,111,2.07522619456168,-0.157602253021443 +-167.95155,52.9749793,13.719616,-933198.495001745,427435.832572936,112.58081817627,111,2.05146440055218,-0.243911871155182 +-167.89778,52.9819283,13.719616,-929494.49803325,427435.833108685,107.611625671387,111,2.03185919226153,-0.315123583550383 +-167.84399,52.9888508,13.719616,-925790.401267451,427435.816618164,109.811210632324,111,2.04064667952414,-0.283204921614027 +-167.79018,52.9957467,13.719616,-922086.202690662,427435.773010948,105.818733215332,111,2.02456255817048,-0.341627041235782 +-167.73635,53.0026161,13.719616,-918381.895693171,427435.713914141,107.119087219238,111,2.02986686331933,-0.32236029093576 +-167.68251,53.0094589,13.719616,-914678.13725215,427435.76698021,112.122444152832,111,2.04969255636008,-0.250347714995559 +-167.62865,53.016275,13.719616,-910974.266273538,427435.78328731,111.963180541992,111,2.04907522698792,-0.252590031478605 +-167.57477,53.0230646,13.719616,-907270.273883843,427435.785352766,116.655685424805,111,2.06690590976886,-0.187823902234671 +-167.52087,53.0298276,13.719616,-903566.158006217,427435.763119247,126.987312316895,111,2.10376033145972,-0.0539581233542205 +-167.46695,53.036564,13.719616,-899861.914290231,427435.717398538,130.628555297852,111,2.11603812374394,-0.00936167734712805 +-167.41302,53.0432737,13.719616,-896158.199623585,427435.773081936,141.628173828125,111,2.15114965533816,0.118173427231928 +-167.35907,53.0499568,13.719616,-892454.348388679,427435.805808449,159.097640991211,111,2.20166374022424,0.301655001693446 +-167.3051,53.0566132,13.719616,-888750.358431867,427435.805541819,176.629806518555,111,2.2470639932067,0.466561679048069 +-167.25111,53.063243,13.719616,-885046.223161698,427435.783998997,201.150390625,210,2.30352088028843,0.671629207328805 +-167.1971,53.069846,13.719616,-881341.9425899,427435.720279452,222.801162719727,210,2.34791745293546,0.832890231226277 +-167.14308,53.0764224,13.719616,-877638.166943021,427435.769148104,234.308609008789,210,2.36978824581559,0.912331193512692 +-167.08904,53.082972,13.719616,-873934.237173858,427435.776446486,258.615692138672,310,2.41265487322215,1.0680350196069 +-167.03498,53.089495,13.719616,-870230.144520604,427435.764812428,309.655548095703,310,2.49087886566567,1.3521668875121 +-166.9809,53.0959912,13.719616,-866525.888909382,427435.713365449,309.535461425781,310,2.49071041044604,1.3515550100725 +-166.92681,53.1024607,13.719616,-862822.122768795,427435.763802662,327.065765380859,310,2.51463508804341,1.43845626788899 +-166.8727,53.1089034,13.719616,-859118.184801956,427435.775100589,452.677551269531,310,2.6557889579335,1.9511674126554 +-166.81857,53.1153193,13.719616,-855414.07056029,427435.748165305,445.286285400391,310,2.64863931927976,1.92519788435499 +-166.76443,53.1217085,12.28746858,-851710.432487798,427435.823053175,468.081176757812,410,2.67032117692197,2.00395257992978 +-169.96751,52.6589381,13.71850247,-1073950.00375581,423731.726433442,286.482116699219,210,2.45709751684005,1.22946338642052 +-169.91453,52.66688,13.719616,-1070246.23422135,423731.785499545,248.210479736328,210,2.39482011397003,1.00325408345613 +-169.86153,52.6747958,13.719616,-1066542.51069361,423731.845852728,227.379653930664,210,2.35675160115663,0.864978379082501 +-169.8085,52.6826857,13.719616,-1062838.16432708,423731.769492137,100.455581665039,111,2.00197407268188,-0.42367486792606 +-169.75546,52.6905495,13.719616,-1059134.51548624,423731.856007296,80.1218566894531,10,1.90375100478331,-0.78044908618841 +-169.70239,52.6983872,13.719616,-1055430.24097255,423731.78638007,56.9730606079102,10,1.75566955049799,-1.31832319480774 +-169.6493,52.7061988,13.719616,-1051725.99630487,423731.721160472,72.7796401977539,10,1.86200990422471,-0.932064677513488 +-169.5962,52.7139844,13.719616,-1048022.4344176,423731.829459795,94.3168869018555,111,1.97458945765469,-0.523143606052093 +-169.54307,52.7217439,13.719616,-1044318.23469716,423731.78484965,125.917419433594,111,2.10008581462399,-0.0673050173131258 +-169.48992,52.7294772,13.719616,-1040614.05521305,423731.735441249,206.946319580078,111,2.31585770713071,0.716440083700932 +-169.43675,52.7371845,13.719616,-1036909.88675891,423731.703352114,182.78303527832,111,2.26193588490486,0.520580634556298 +-169.38357,52.7448656,9.854838722,-1033206.3899505,423731.823129259,79.1210861206055,111,1.89829224033012,-0.800276876768874 +-169.11733,52.7828785,12.487205,-1014686.29483821,423731.801239763,49.9017372131348,10,1.69811566484074,-1.52737533502934 +-169.06402,52.7904024,13.719616,-1010982.12455925,423731.753914291,22.0041370391846,10,1.34250434102124,-2.81905716471889 +-169.01069,52.7979002,13.719616,-1007277.93504097,423731.717710101,62.0209617614746,10,1.79253849657501,-1.18440465921111 +-168.95735,52.8053717,13.719616,-1003574.38670263,423731.822734529,60.1954727172852,10,1.77956382933362,-1.23153235397054 +-168.90398,52.8128169,13.719616,-999870.156232228,423731.766807184,48.9475517272949,10,1.68973097401623,-1.55783092533297 +-168.85059,52.8202358,13.719616,-996165.899035316,423731.702217899,62.964656829834,10,1.79909684070916,-1.16058288137809 +-168.79719,52.8276285,13.719616,-992462.268062508,423731.789850702,87.419319152832,10,1.94160741975465,-0.642943781715928 +-168.74376,52.8349949,13.719616,-988757.942457887,423731.720083161,84.8659820556641,10,1.92873364117323,-0.689705020065868 +-168.69032,52.8423349,13.719616,-985054.239622293,423731.781061718,91.4287796020508,10,1.96108292281249,-0.572203195747819 +-168.63686,52.8496486,13.719616,-981350.493346537,423731.834810304,83.8007202148438,10,1.9232477511361,-0.70963133850962 +-168.58337,52.856936,13.719616,-977646.039868311,423731.734774831,100.956359863281,10,2.00413368302733,-0.415830546737206 +-168.52987,52.8641971,13.719616,-973942.1941429,423731.776601276,129.138061523438,10,2.11105426297432,-0.0274644821978856 +-168.47635,52.8714317,13.719616,-970238.29719761,423731.791534796,161.28337097168,111,2.20758959201679,0.323179386810508 +-168.42281,52.87864,13.719616,-966534.339999683,423731.80190851,281.257354736328,111,2.44910388784703,1.20042824430901 +-168.36925,52.8858219,13.719616,-962830.320726146,423731.797578787,163.346618652344,111,2.21311014881557,0.343231624827459 +-168.31567,52.8929774,13.719616,-959126.235142571,423731.779237981,111.502113342285,111,2.04728309881194,-0.259099552538084 +-168.26207,52.9001065,13.719616,-955422.079010567,423731.747586761,113.748077392578,111,2.05594406480299,-0.227640451972766 +-168.20846,52.9072092,13.719616,-951718.507661666,423731.846641351,364.907440185547,210,2.56218271838955,1.61116283275101 +-168.15482,52.9142854,13.719616,-948014.200048411,423731.779104865,584.832153320312,310,2.76703124155876,2.35523113849124 +-168.10117,52.9213351,13.719616,-944310.47104214,423731.831753672,223.469955444336,310,2.34921914240383,0.837618338914554 +-168.04749,52.9283584,13.719616,-940605.994885779,423731.7312208,295.040649414062,111,2.4698818553003,1.27589975272165 +-167.9938,52.9353552,13.719616,-936902.088789347,423731.751226407,298.61083984375,210,2.47510556895792,1.29487377172244 +-167.94009,52.9423255,13.719616,-933198.088890857,423731.750323778,328.987030029297,111,2.51717877668025,1.44769567105902 +-167.88636,52.9492693,13.719616,-929493.990898278,423731.729266401,169.988082885742,111,2.23041847597607,0.406100409362797 +-167.83262,52.9561866,13.719616,-925790.450089564,423731.828219296,126.948196411133,111,2.10362653510925,-0.0544441098884094 +-167.77885,52.9630773,13.719616,-922086.145302523,423731.757732974,337.635559082031,210,2.52844817936316,1.4886293582111 +-167.72507,52.9699416,13.719616,-918382.386801835,423731.818545251,633.284301757812,210,2.80159872260105,2.48079009617821 +-167.67127,52.9767792,13.719616,-914678.517535783,423731.83946616,144.606063842773,111,2.16018650484122,0.150997844000691 +-167.61745,52.9835903,13.719616,-910974.52862239,423731.843004313,145.708709716797,111,2.16348551243499,0.162980781211777 +-167.56361,52.9903748,13.719616,-907270.417996709,423731.819100416,165.133239746094,111,2.21783450139915,0.360391821875497 +-167.50975,52.9971327,13.719616,-903566.181313399,423731.768562032,183.783203125,111,2.26430581649803,0.529188902548512 +-167.45588,53.003864,13.719616,-899862.473797173,423731.827704211,206.080261230469,111,2.31403639619835,0.709824562540702 +-167.40198,53.0105687,13.719616,-896157.971947336,423731.725796378,233.140014648438,210,2.36761681942187,0.904443953063889 +-167.34807,53.0172468,13.719616,-892453.990554849,423731.73411208,213.644622802734,210,2.32969196658224,0.766690062719672 +-167.29415,53.0238982,13.719616,-888750.527465428,423731.840946576,229.26416015625,210,2.36033616871635,0.877998551596842 +-167.2402,53.030523,13.719616,-885046.256943153,423731.789811813,248.557647705078,210,2.39542713019889,1.00545893965901 +-167.18624,53.0371211,13.719616,-881342.4959563,423731.83778349,282.469329833984,310,2.45097129956444,1.20721121667903 +-167.13225,53.0436925,13.69522105,-877637.920958866,423731.719746311,555.358825683594,410,2.74457367800467,2.27365885763598 +-167.02424,53.0567553,13.17033791,-870230.266601301,423731.792938743,662.436401367188,410,2.82114418923356,2.55178480981908 +-166.97021,53.0632466,13.719616,-866526.521023019,423731.841231002,512.440246582031,310,2.70964323149827,2.14678150578267 +-166.91615,53.0697112,13.719616,-862821.943803562,423731.728169476,471.813720703125,410,2.67377056634824,2.01648174687976 +-169.95454,52.6264909,13.719616,-1073950.49603427,420027.848548937,230.915969848633,210,2.36345396919827,0.889323292856024 +-169.90159,52.6344269,13.719616,-1070246.08741762,420027.743439363,240.581344604492,210,2.38126194781911,0.954006954110075 +-169.84863,52.642337,13.719616,-1066542.37695464,420027.82029897,212.450637817383,210,2.32725803926246,0.757849343982187 +-169.79564,52.650221,13.719616,-1062838.0456165,420027.736330856,97.5040664672852,111,1.98902272859572,-0.470717846328617 +-169.74264,52.658079,13.719616,-1059134.40701682,420027.823449054,70.2740631103516,10,1.84679506432976,-0.987329318759627 +-169.68961,52.665911,13.719616,-1055430.13686811,420027.762647008,67.5733795166016,10,1.82977563963992,-1.04914872706054 +-169.63656,52.6737169,13.719616,-1051725.89386021,420027.703704145,68.7735214233398,10,1.83742126217205,-1.02137764374593 +-169.5835,52.6814967,13.719616,-1048022.33406642,420027.804952008,93.4627914428711,10,1.97063874790733,-0.537493711499337 +-169.53041,52.6892505,13.719616,-1044318.13059164,420027.761533626,132.128189086914,111,2.12099548270818,0.00864486538208711 +-169.4773,52.6969781,13.719616,-1040613.94464845,420027.71078307,202.227523803711,111,2.30584026412633,0.680053871446115 +-169.42418,52.7046797,13.719616,-1036910.4271674,420027.830957403,139.293533325195,111,2.14393095485631,0.0919530466596285 +-169.37103,52.7123551,8.970071015,-1033206.25892369,420027.788203285,75.6193084716797,111,1.87863270148054,-0.871685933261617 +-169.15824,52.7427953,9.841014236,-1018390.24255845,420027.784222978,48.0710906982422,10,1.68188397606778,-1.58633346163795 +-169.10499,52.7503399,13.719616,-1014686.05455711,420027.739849275,75.9631423950195,10,1.88060292205483,-0.864529529778853 +-169.05173,52.7578583,13.719616,-1010982.51140105,420027.844933213,84.5880432128906,10,1.92730897848048,-0.694879801605146 +-168.99844,52.7653505,13.719616,-1007278.28869787,420027.79505845,89.6216430664062,10,1.95241290172981,-0.603695186990526 +-168.94513,52.7728165,13.719616,-1003574.04244588,420027.743625291,81.3938903808594,10,1.91059180693513,-0.755601340213658 +-168.89181,52.7802562,13.719616,-999870.431105438,420027.83099839,88.243522644043,10,1.94568283662993,-0.628140704385115 +-168.83846,52.7876696,13.719616,-996166.130246056,420027.756125606,78.2669143676758,10,1.89357821232369,-0.817399572005797 +-168.7851,52.7950568,13.719616,-992462.453510834,420027.831011017,75.2113189697266,10,1.87628320490247,-0.880219975446263 +-168.73171,52.8024177,13.719616,-988758.078927291,420027.746036995,103.008712768555,10,2.0128739601156,-0.384083365629158 +-168.67831,52.8097523,13.719616,-985054.322579247,420027.80017603,104.89729309082,10,2.02076428122608,-0.355423467234016 +-168.62489,52.8170606,13.719616,-981350.520151715,420027.844639526,115.251960754395,111,2.06164832267401,-0.206920959227931 +-168.57144,52.8243426,13.719616,-977646.007325724,420027.732878012,106.566909790039,10,2.02762237235921,-0.330512922744423 +-168.51798,52.8315982,13.719616,-973942.102578502,420027.749714672,160.160461425781,111,2.20455531134892,0.312158013354855 +-168.35748,52.853207,13.719616,-962830.024268634,420027.735295783,273.838073730469,111,2.43749383116645,1.15825720460504 +-168.30395,52.8603572,13.719616,-959126.524481429,420027.848354633,292.322998046875,210,2.46586298412908,1.26130206552772 +-168.25039,52.8674809,13.719616,-955422.293759795,420027.789875838,168.431198120117,111,2.22642253797417,0.391586021985639 +-168.19681,52.8745783,13.719616,-951717.983261587,420027.727226879,488.003021240234,310,2.68842251074021,2.06970179099269 +-168.08961,52.8886937,12.51234321,-944310.437997645,420027.822503076,524.40966796875,310,2.71967068970526,2.18320409611199 +-167.82126,52.9235192,13.719616,-925789.94521215,420027.721522511,667.105590820312,310,2.82419458036512,2.56286470107724 +-167.60626,52.9509024,13.719616,-910974.254669926,420027.785528551,428.932006835938,210,2.63238845443118,1.86617010476631 +-167.55246,52.9576818,13.719616,-907270.02988285,420027.735926143,240.19367980957,210,2.3805615756733,0.951463002570376 +-167.49865,52.9644347,13.719616,-903566.334361735,420027.804273932,575.431274414062,410,2.75999346189277,2.32966791396204 +-167.3371,52.9845337,13.719616,-892454.434862229,420027.826192629,561.095153808594,310,2.74903651770849,2.28986916526152 +-167.28321,52.9911801,13.719616,-888750.183585589,420027.771622747,510.655822753906,310,2.70812828831554,2.14127879973519 +-167.22931,52.9977999,13.719616,-885046.442037074,420027.824423052,552.534973144531,310,2.74235977224491,2.26561732000489 +-169.99446,52.5860839,8.365027482,-1077654.05229523,416323.739804468,217.673675537109,210,2.33780591062012,0.79616222341545 +-169.94158,52.5940401,13.719616,-1073950.28425557,416323.797533808,233.57746887207,210,2.36843094795895,0.90740110028599 +-169.88867,52.6019703,13.719616,-1070245.89745819,416323.700521629,268.024719238281,210,2.42817484975161,1.12440800420425 +-169.83575,52.6098745,13.719616,-1066542.20927081,416323.772131467,208.667602539062,210,2.31945502630214,0.729506573708676 +-169.7828,52.6177528,13.719616,-1062837.89168952,416323.701890512,98.8759765625,111,1.9950907858975,-0.448676930212576 +-169.72984,52.625605,13.719616,-1059134.26730245,416323.789398509,73.3069458007812,10,1.86514512580129,-0.920676657866013 +-169.67685,52.6334312,13.719616,-1055430.00808885,416323.726426707,78.4840927124023,10,1.89478164213014,-0.813028371455701 +-169.62385,52.6412314,13.719616,-1051726.43139982,416323.831907511,77.7479705810547,10,1.8906890616609,-0.827893791858734 +-169.57082,52.6490055,13.719616,-1048022.21440084,416323.778301427,85.8710632324219,10,1.93384684024954,-0.671132421568381 +-169.51777,52.6567535,13.719616,-1044318.01371972,416323.725068108,181.16227722168,111,2.25806777115529,0.506530541348273 +-169.46471,52.6644755,13.719616,-1040614.48342144,416323.840232583,236.98681640625,111,2.37472418684862,0.930259940202504 +-169.41162,52.6721714,13.719616,-1036910.30063341,416323.799618488,144.17805480957,111,2.15889916190631,0.146321847016847 +-169.35851,52.6798412,11.05253105,-1033206.1219711,416323.76103571,108.480560302734,111,2.03535191966234,-0.302437000706979 +-169.14588,52.7102589,13.719616,-1018390.04018302,416323.737815071,76.0856094360352,10,1.88130252361011,-0.861988377243916 +-169.09268,52.7177979,13.719616,-1014686.48903977,416323.837861069,92.6494750976562,10,1.96684296318177,-0.551281085047414 +-169.03945,52.7253108,13.719616,-1010982.25675226,416323.790099731,93.8329391479492,10,1.97235532003186,-0.531258631584599 +-168.9862,52.7327974,13.719616,-1007278.00486988,416323.726875903,95.3909072875977,10,1.97950697949422,-0.505281763130468 +-168.93294,52.7402579,13.719616,-1003574.38497865,416323.821535407,83.0869445800781,10,1.9195327886185,-0.723125142729415 +-168.87965,52.7476921,13.719616,-999870.076517369,416323.750295196,101.290237426758,10,2.00556758913122,-0.410622190490328 +-168.82635,52.7551,13.719616,-996166.396698438,416323.815454488,107.201751708984,10,2.03020188191767,-0.321143407762762 +-168.77302,52.7624817,13.719616,-992462.017526251,416323.727906024,114.889472961426,111,2.0602802371808,-0.211890236229748 +-168.71968,52.7698372,13.719616,-988758.256231124,416323.787740628,123.641487121582,111,2.09216421998244,-0.0960785100994468 +-168.66632,52.7771664,13.719616,-985054.450400685,416323.834793877,120.865112304688,111,2.08230095991707,-0.131904685911601 +-168.61293,52.7844692,13.719616,-981349.937583942,416323.711132014,151.974700927734,111,2.18177129740563,0.229399971507817 +-168.50611,52.7989961,13.719616,-973942.065568383,416323.748408964,460.275695800781,210,2.66301804320099,1.9774255137333 +-169.98149,52.5536353,11.74574644,-1077654.43122948,412619.830272248,221.859268188477,210,2.34607757611787,0.826207273471671 +-169.92864,52.5615857,13.719616,-1073950.03100223,412619.736197038,185.749649047852,210,2.26892800188497,0.545977999176927 +-169.87578,52.5695101,13.719616,-1070246.33123175,412619.808224982,257.885192871094,111,2.41142640674054,1.06357287870645 +-169.82289,52.5774085,13.719616,-1066542.00541373,412619.723989692,223.373428344727,210,2.3490315098288,0.836936803846395 +-169.76999,52.585281,13.719616,-1062838.36942021,412619.816526759,171.609848022461,210,2.23454220670087,0.421078976385198 +-169.71706,52.5931275,13.719616,-1059134.09936352,412619.754945514,93.6852111816406,10,1.97167104009681,-0.533744131621614 +-169.66412,52.6009479,13.719616,-1055430.51630599,412619.848511422,95.0709609985352,10,1.9780478838779,-0.510581614876297 +-169.61115,52.6087424,13.719616,-1051726.28853674,412619.800907434,90.8751068115234,10,1.95844493432242,-0.581785122900638 +-169.55816,52.6165108,13.719616,-1048022.07844493,412619.750593395,94.5240020751953,10,1.97554210105151,-0.51968333332335 +-169.50515,52.6242531,13.719616,-1044317.88196993,412619.698109819,122.265174865723,111,2.087302773329,-0.11373667193978 +-169.45213,52.6319694,13.719616,-1040614.35373761,412619.811486288,193.029418945312,210,2.28562350337023,0.606620825941947 +-169.39908,52.6396596,13.719616,-1036910.16975855,412619.766551403,196.275024414062,210,2.29286504005217,0.632924154111135 +-169.34601,52.6473237,13.719616,-1033205.98720688,412619.721119775,131.958557128906,111,2.12043755820416,0.00661832433601034 +-169.29293,52.6549617,12.80891191,-1029502.46325264,412619.830782879,115.701309204102,111,2.06333827318598,-0.200782576608566 +-169.18669,52.6701594,13.3545547,-1022094.06857241,412619.741505827,104.447158813477,10,2.01889663073651,-0.362207306892661 +-169.13355,52.677719,13.719616,-1018390.51467104,412619.841871132,109.074012756348,111,2.03772129081851,-0.293830768381925 +-169.08038,52.6852525,13.719616,-1014686.28050683,412619.790768892,112.60474395752,111,2.0515566874174,-0.243576658919405 +-169.02719,52.6927598,13.719616,-1010982.02571717,412619.731908915,110.905685424805,111,2.04495381021886,-0.267560193553279 +-168.97399,52.7002409,13.719616,-1007278.4074219,412619.817577285,113.909812927246,111,2.0565611386233,-0.225399063727015 +-168.92076,52.7076959,13.719616,-1003574.09652517,412619.755300597,121.653823852539,111,2.08512576433102,-0.121644190000673 +-168.86752,52.7151246,13.719616,-999870.41633531,412619.826878553,138.927291870117,111,2.14278757003064,0.0877999466182604 +-168.81425,52.7225271,13.719616,-996166.037739782,412619.742082615,156.172180175781,111,2.19360367312516,0.272378537417401 +-168.76097,52.7299033,13.719616,-992462.281533931,412619.791299186,247.833389282227,111,2.39415981618119,1.00085569341929 +-168.70767,52.7372533,13.719616,-988758.479861541,412619.835435704,565.133361816406,310,2.75215094599034,2.30118165772753 +-168.601,52.7518745,13.719616,-981350.067097935,412619.741706668,648.914306640625,410,2.81218734917275,2.51925101018157 +-169.96853,52.5211831,13.70772829,-1077654.10704896,408915.749454523,222.241973876953,210,2.34682608566524,0.828926073793594 +-169.91573,52.5291277,13.719616,-1073950.40108889,408915.827345683,176.456344604492,111,2.24663727832185,0.465011728789761 +-169.8629,52.5370463,13.719616,-1070246.06981294,408915.745332818,246.587707519531,111,2.39197142307278,0.992906825019956 +-169.81006,52.5449389,13.719616,-1066542.43282144,408915.826789124,207.247375488281,210,2.3164890394965,0.718733263053688 +-169.75719,52.5528056,13.719616,-1062838.15988571,408915.761250959,153.333465576172,210,2.18563695152046,0.243441130620394 +-169.7043,52.5606463,13.719616,-1059133.91141566,408915.699623902,117.524864196777,111,2.07012975802133,-0.176113965203816 +-169.6514,52.5684611,13.719616,-1055430.34260588,408915.812139882,116.948654174805,111,2.06799522838699,-0.183867186091126 +-169.59847,52.5762498,13.719616,-1051726.13100648,408915.759373499,117.604553222656,111,2.07042413637613,-0.175044698995234 +-169.54552,52.5840125,13.719616,-1048021.93179526,408915.71212764,114.415451049805,111,2.05848467701433,-0.218412223258252 +-169.49256,52.5917491,13.719616,-1044318.40530583,408915.817418894,175.217041015625,111,2.24357634189571,0.453893534011774 +-169.43957,52.5994598,13.719616,-1040614.21875617,408915.78231761,226.519470214844,210,2.35510553722502,0.858999405049492 +-169.38656,52.6071443,13.719616,-1036910.03757166,408915.732835161,207.492614746094,111,2.31700264354402,0.720598819551483 +-169.33354,52.6148028,13.719616,-1033206.51438513,408915.846696158,164.724334716797,111,2.2167577622089,0.35648079780456 +-169.28049,52.6224352,13.719616,-1029502.3240651,408915.801976304,136.282806396484,111,2.13444106817408,0.0574830695464101 +-169.22742,52.6300415,13.719616,-1025798.1243362,408915.755395148,134.479904174805,111,2.12865739097002,0.0364751031154511 +-169.17433,52.6376217,13.719616,-1022093.91111419,408915.707544916,122.990310668945,111,2.08987089852263,-0.104408508220607 +-169.12123,52.6451758,13.719616,-1018390.34211556,408915.812372215,126.479957580566,111,2.10202171126848,-0.0602732881404165 +-169.0681,52.6527037,13.719616,-1014686.0921325,408915.752430973,126.30541229248,111,2.10142196083559,-0.062451752898497 +-169.01496,52.6602054,13.719616,-1010982.48065243,408915.834465942,135.439758300781,111,2.13174617008072,0.0476944304708365 +-168.96179,52.667681,13.719616,-1007278.17746255,408915.764882527,144.190567016602,111,2.15893684965776,0.146458739687289 +-168.90861,52.6751305,13.719616,-1003574.50206806,408915.848216959,158.256423950195,111,2.19936134794372,0.293292055762434 +-168.8554,52.6825537,13.719616,-999870.131670269,408915.760696353,641.467529296875,310,2.8071746775401,2.50104355605284 +-169.9556,52.4887273,13.719616,-1077654.4058153,405211.822986084,225.459075927734,210,2.35306772265876,0.851597480894647 +-169.90283,52.4966661,13.719616,-1073950.07447462,405211.748647304,185.082717895508,111,2.26736586838543,0.540303884429312 +-169.85005,52.5045789,13.719616,-1070246.43926586,405211.835245973,226.419189453125,111,2.35491323135209,0.858300895229424 +-169.79724,52.5124658,13.719616,-1066542.16884358,405211.771197687,235.167587280273,210,2.37137746351228,0.918103685794957 +-169.74441,52.5203267,13.719616,-1062837.92418668,405211.70796532,180.792190551758,111,2.2571796668831,0.503304693141501 +-169.69157,52.5281617,13.719616,-1059134.36104617,405211.816333209,170.225128173828,111,2.23102366985972,0.408298646287767 +-169.6387,52.5359707,13.719616,-1055430.15328798,405211.766541514,167.938583374023,111,2.22515048542573,0.386965564049768 +-169.58581,52.5437537,13.719616,-1051725.95924972,405211.71917079,189.508392333984,111,2.27762844735757,0.57758050048782 +-169.53291,52.5515107,13.719616,-1048022.43726486,405211.832578357,278.674652099609,111,2.44509746762285,1.18587578250861 +-169.47998,52.5592417,13.719616,-1044318.25857514,405211.791146327,338.942718505859,310,2.53012630841306,1.49472480190605 +-169.42703,52.5669466,13.719616,-1040614.08405793,405211.74301728,352.451171875,310,2.54709895890446,1.55637431296759 +-169.37406,52.5746256,13.719616,-1036909.90455919,405211.710337107,271.959991455078,210,2.43450501885664,1.14740098520385 +-169.32108,52.5822784,13.719616,-1033206.3860266,405211.816892703,259.409057617188,210,2.4139851359905,1.07286691367635 +-169.26807,52.5899052,13.719616,-1029502.19458143,405211.773135176,485.633666992188,210,2.68630878696773,2.0620241429342 +-169.21504,52.5975059,13.719616,-1025797.9910505,405211.724998594,623.011291503906,410,2.79449591791663,2.45499068222212 +-169.162,52.6050805,13.719616,-1022094.43371307,405211.826984078,190.672653198242,111,2.28028840979092,0.587242243274584 +-169.10893,52.612629,13.719616,-1018390.19375668,405211.771330235,474.240173339844,210,2.67599834070251,2.02457365920458 +-169.05584,52.6201514,13.719616,-1014685.92945249,405211.713111758,547.19873046875,310,2.73814508112607,2.25030835886865 +-169.00274,52.6276476,13.719616,-1010982.30155107,405211.794374909,640.690185546875,310,2.80664807127533,2.4991307717908 +-168.94961,52.6351177,13.719616,-1007277.97872725,405211.721529587,293.959991455078,210,2.4682882260834,1.2701112365388 +-168.89647,52.6425616,13.719616,-1003574.2840689,405211.788306964,341.222595214844,210,2.53303778173411,1.50530010402532 +-169.99539,52.4483091,8.1682873,-1081358.32709248,401507.810148027,201.989486694336,210,2.30532876553841,0.678195962578589 +-169.94268,52.4562679,13.719616,-1077654.006372,401507.727418634,211.1923828125,210,2.3246782502152,0.748478813817468 +-169.88996,52.4642008,13.719616,-1073950.38096558,401507.813850105,228.147705078125,210,2.35821610459271,0.870297873573231 +-169.83721,52.4721079,13.719616,-1070246.1184365,401507.756744103,242.905868530273,111,2.38543800735156,0.969175594297982 +-169.78444,52.479989,13.719616,-1066541.88296786,401507.697355305,231.679763793945,111,2.36488810173805,0.894532471582718 +-169.73166,52.4878442,13.719616,-1062838.33086709,401507.807020489,236.089920043945,210,2.37307744509336,0.924278504120511 +-169.67885,52.4956734,13.719616,-1059134.13489592,401507.754863845,243.73957824707,210,2.38692605531806,0.974580609243491 +-169.62602,52.5034767,13.719616,-1055429.95137059,401507.712799686,245.180130004883,210,2.38948527098952,0.983876411035134 +-169.57318,52.511254,13.719616,-1051726.44178845,401507.828965595,280.283538818359,210,2.44759759219382,1.19495694855698 +-169.52031,52.5190054,13.719616,-1048022.27371375,401507.797408578,412.326110839844,310,2.61524083767452,1.80388506628901 +-169.46742,52.5267307,13.719616,-1044318.11117702,401507.75604938,419.666229248047,310,2.62290402272277,1.83171994167504 +-169.41451,52.53443,13.719616,-1040613.94756637,401507.71623826,594.054016113281,410,2.77382593628315,2.37991140912919 +-169.30864,52.5497505,13.719616,-1033206.26641063,401507.788360748,586.639465332031,310,2.76837127616822,2.36009852667675 +-169.20269,52.5649668,13.51523641,-1025798.53741839,401507.849866462,520.061706542969,410,2.71605487675244,2.17007043141159 +-169.98246,52.4158518,11.551655,-1081358.51331076,397803.848706352,272.277526855469,310,2.43501179717753,1.14924174871425 +-169.92979,52.4238049,13.719616,-1077654.23701393,397803.788383279,204.22673034668,210,2.31011258438318,0.695572158060628 +-169.8771,52.431732,13.719616,-1073949.99303654,397803.72215364,238.913665771484,210,2.37824099194077,0.943033980093296 +-169.8244,52.4396333,13.719616,-1070246.43562218,397803.833224402,238.962188720703,210,2.37832918743743,0.943354331310657 +-169.77167,52.4475087,13.719616,-1066542.23646648,397803.788489721,298.338623046875,310,2.47470948095279,1.29343506703305 +-169.71892,52.4553581,13.719616,-1062838.05766103,397803.73942232,204.824005126953,210,2.31138085407739,0.700178875590211 +-169.66615,52.4631816,13.719616,-1059133.89260048,397803.69733409,255.853515625,210,2.40799138889089,1.05109591342483 +-169.61337,52.4709792,13.719616,-1055430.40076932,397803.821698567,272.347991943359,210,2.43512417751209,1.14964994616594 +-169.56056,52.4787508,13.719616,-1051726.25378719,397803.783886678,328.365844726562,310,2.51635797725918,1.44471429328221 +-169.91692,52.3913382,13.719616,-1077654.44102234,394099.833933242,407.039123535156,310,2.60963615448034,1.78352725719189 +-169.86427,52.3992596,13.719616,-1073950.24272918,394099.78730226,400.083892822266,310,2.60215106725198,1.7563392839219 +-169.8116,52.4071551,13.719616,-1070246.0674402,394099.743462875,504.272674560547,410,2.70266543532333,2.12143615841399 +-169.70621,52.4228684,13.48100482,-1062838.43398492,394099.826332238,486.240325927734,410,2.68685097384431,2.06399352042548 +-169.65348,52.4306862,13.719616,-1059134.30380977,394099.793529856,352.082702636719,310,2.54664468927367,1.55472427600709 +-169.60073,52.4384781,13.719616,-1055430.18069267,394099.765691054,389.00732421875,310,2.58995777828674,1.71204977808899 +-169.54796,52.4462441,13.719616,-1051726.06063687,394099.743377875,447.221343994141,310,2.65052252242236,1.93203821568859 +-169.49517,52.4539841,13.719616,-1048021.94220414,394099.716377058,618.383666992188,410,2.79125801029442,2.44322967754739 +-169.64082,52.3981873,13.719616,-1059134.04144447,390395.736343501,534.030578613281,410,2.72756612546076,2.21188257235768 +-169.58811,52.4059735,13.719616,-1055429.95450516,390395.715557315,556.813354492188,410,2.74570964275321,2.27778500583931 +-169.53539,52.4137338,13.719616,-1051726.53252941,390395.85610064,643.556762695312,410,2.80858685837041,2.50617299990508 diff --git a/data/GOA/vast_data/prednll_VAST_models.RData b/data/GOA/vast_data/prednll_VAST_models.RData new file mode 100644 index 0000000..7c1e7d7 Binary files /dev/null and b/data/GOA/vast_data/prednll_VAST_models.RData differ