diff --git a/src/lisfloodutilities/catchstats/catchstats.py b/src/lisfloodutilities/catchstats/catchstats.py index 262268b..9b91c2d 100644 --- a/src/lisfloodutilities/catchstats/catchstats.py +++ b/src/lisfloodutilities/catchstats/catchstats.py @@ -196,7 +196,7 @@ def catchment_statistics(maps: Union[xr.DataArray, xr.Dataset], if output is not None: fileout = output / f'{ID:04}.nc' - if fileout.exists() and ~overwrite: + if fileout.exists() and not overwrite: print(f'Output file {fileout} already exists. Moving forward to the next catchment') continue @@ -252,7 +252,7 @@ def main(argv=sys.argv): parser.add_argument("-s", "--statistic", nargs='+', required=True, help='List of statistics to be computed. Possible values: mean, sum, std, var, min, max, median, count') parser.add_argument("-o", "--output", required=True, help="Directory where the output NetCDF files will be saved") parser.add_argument("-a", "--area", required=False, default=None, help="NetCDF file of pixel area used to weigh the statistics") - parser.add_argument("-W", "--overwrite", action="store_true", help="Overwrite existing output files") + parser.add_argument("-w", "--overwrite", action="store_true", default=False, help="Overwrite existing output files") args = parser.parse_args() diff --git a/src/lisfloodutilities/ncextract/ncextract.py b/src/lisfloodutilities/ncextract/ncextract.py index 2882359..f9d6ba0 100644 --- a/src/lisfloodutilities/ncextract/ncextract.py +++ b/src/lisfloodutilities/ncextract/ncextract.py @@ -11,6 +11,7 @@ """ import argparse +import numpy as np import pandas as pd import os import sys @@ -18,10 +19,13 @@ import xarray as xr import cfgrib from pathlib import Path -from typing import Union, Optional +from typing import Union, Optional, Tuple +from datetime import datetime + + def read_points(inputcsv: Union[str, Path]) -> xr.Dataset: - """It reads a CSV file with coordinates of points: gauging stations, reservoirs... + """Reads a CSV file with the coordinates of the points of interest: gauging stations, reservoirs... Parameters: ----------- @@ -35,37 +39,47 @@ def read_points(inputcsv: Union[str, Path]) -> xr.Dataset: """ if not os.path.isfile(inputcsv): - print(f'ERROR: {inputcsv} is missing!') - sys.exit(1) + raise FileNotFoundError(f'{inputcsv} does not exist!') try: + # read input CSV poi_df = pd.read_csv(inputcsv) original_columns = poi_df.columns.copy() poi_df.columns = original_columns.str.lower() + # find columns representing coordinates - coord_1 = [col for col in poi_df.columns if col.startswith('lon') or col.startswith('x')][0] - coord_2 = [col for col in poi_df.columns if col.startswith('lat') or col.startswith('y')][0] + x_coord = [col for col in poi_df.columns if col.startswith('lon') or col.startswith('x')][0] + y_coord = [col for col in poi_df.columns if col.startswith('lat') or col.startswith('y')][0] + # find the column representing the point ID - idx_col = poi_df.columns.difference([coord_1, coord_2])[0] + idx_col = poi_df.columns.difference([x_coord, y_coord])[0] + # convert to xarray.Dataset - poi_xr = poi_df.set_index(idx_col)[[coord_1, coord_2]].to_xarray() + poi_xr = poi_df.set_index(idx_col)[[x_coord, y_coord]].to_xarray() rename_dim = {idx_col: col for col in original_columns if col.lower() == idx_col} - poi_xr = poi_xr.rename(rename_dim) + poi_xr = poi_xr.rename({idx_col: 'id'}) except: - print('ERROR: Please check that the CSV file is formatted correctly!') - sys.exit(2) - + raise ValueError(f"Could not read CSV properly. Please check the format.\nDetails: {e}") + return poi_xr -def read_inputmaps(directory: Union[str, Path]) -> xr.Dataset: - """It extract from a series of input files (NetCDF or GRIB) the time series of a set of points +def read_inputmaps( + directory: Union[str, Path], + start: datetime = None, + end: datetime = None +) -> xr.Dataset: + """Reads a set of input files (NetCDF or GRIB) and selects the period of interest Parameters: ----------- - directory: string or pathlib.Path + directory: string or pathlib.Path the directory containing the input files, which can be either in NetCDF or GRIB format + start: datetime + Start of the extraction period + end: datetime + End of the extraction period Returns: -------- @@ -73,81 +87,263 @@ def read_inputmaps(directory: Union[str, Path]) -> xr.Dataset: containing the concatenation of all the input maps """ - pattern_engine = {'*.nc': 'netcdf4', - '*.grib': 'cfgrib'} + pattern_engine = { + '*.nc': 'netcdf4', + '*.grib': 'cfgrib' + } if not os.path.isdir(directory): - print(f'ERROR: {directory} is missing or not a directory!') - sys.exit(1) - else: - directory = Path(directory) - + raise FileNotFoundError(f'{directory} is missing or not a directory!') + + directory = Path(directory) filepaths = [] for pattern, engine in pattern_engine.items(): filepaths = list(directory.glob(pattern)) - if len(filepaths) > 0: + if filepaths: break if not filepaths: - print(f'ERROR: No NetCDF/GRIB file found in {directory}') - sys.exit(2) + raise FileNotFoundError(f'No NetCDF/GRIB files found in {directory}') print(f'{len(filepaths)} input {engine} file(s) found in "{directory}"') - - # chunks is set to auto for general purpose processing - # it could be optimized depending on input NetCDF - maps = xr.open_mfdataset(filepaths, engine=engine, chunks='auto', parallel=True) + + try: + # load dataset + maps = xr.open_mfdataset(filepaths, engine=engine, chunks='auto', parallel=True) + # Note: chunks is set to auto for general purpose processing + # it could be optimized depending on input NetCDF + except Exception as e: + raise RuntimeError(f'Failed to open datasets using engine "{engine}": {str(e)}') + + # Validate start and end dates + if start and not isinstance(start, datetime): + raise ValueError(f"The 'start' parameter must be a datetime object, got {type(start)}") + if end and not isinstance(end, datetime): + raise ValueError(f"The 'end' parameter must be a datetime object, got {type(end)}") + + if start or end: + time_dims = [dim for dim in maps.dims if 'time' in dim.lower()] + if not time_dims: + print('WARNING: No time dimension found, skipping time filtering') + return maps + try: + maps = maps.sel({time_dims[0]: slice(start, end)}) + except Exception as e: + raise ValueError(f'Failed to apply time filter: {str(e)}') return maps -def extract_timeseries(maps: xr.Dataset, - poi: xr.Dataset, - outputfile: Optional[Union[str, Path]] = None - ) -> Optional[xr.Dataset]: - """It extract from a series of input files (NetCDF or GRIB) the time series of a set of points +def read_ldd( + file: Union[str, Path], +) -> xr.DataArray: + """Reads the local drainage direction map + + Parameters: + ----------- + file: string or pathlib.Path + the NetCDF file of the local drainage direction map + + Returns: + -------- + ldd: xarray.DataArray + """ + + return xr.open_dataset(file)['Band1'] + + +def rename_geographic_coords( + target: Union[xr.Dataset, xr.DataArray], + reference: Union[xr.Dataset, xr.DataArray] +) -> Union[xr.Dataset, xr.DataArray]: + """Renames the geographical coordinates/variables in the target dataset to match those in the reference dataset. + + Parameters: + ----------- + target: xarray.Dataset or xarray.DataArray + Object whose geographical coordinates will be renamed + target: xarray.Dataset or xarray.DataArray + Reference names of the geographical coordinates + + Returns: + -------- + A similar object as 'target', but with the names of the geographical coordinates in 'reference' + """ + + # names of geographical coordinates in the target dataset + try: + x_obj = [coord for coord in target.coords if coord.startswith('lon') or coord.startswith('x')][0] + except: + x_obj = [coord for coord in target.variables if coord.startswith('lon') or coord.startswith('x')][0] + try: + y_obj = [coord for coord in target.coords if coord.startswith('lat') or coord.startswith('y')][0] + except: + y_obj = [coord for coord in target.variables if coord.startswith('lat') or coord.startswith('y')][0] + + # names of geographical coordinates in the reference dataset + try: + x_ref = [coord for coord in reference.coords if coord.startswith('lon') or coord.startswith('x')][0] + except: + x_ref = [coord for coord in reference.variables if coord.startswith('lon') or coord.startswith('x')][0] + try: + y_ref = [coord for coord in reference.coords if coord.startswith('lat') or coord.startswith('y')][0] + except: + y_ref = [coord for coord in reference.variables if coord.startswith('lat') or coord.startswith('y')][0] + + return target.rename({x_obj: x_ref, y_obj: y_ref}) + + + +def find_inflow_points( + lat: float, + lon: float, + ldd: xr.DataArray +) -> xr.Dataset: + """This function finds the upstream coordinates of the pixels flowing into the input coordinates + + Parameteres: + ------------ + lat: float + latitude of the input point + lon: float + longitued of the input point + ldd: xarray.DataArray + map of local drainage directions + + Returns: + -------- + points: xarra.Dataset + Contains the coordinates of the pixels flowing into the point of interest. + """ + + # Determine coordinate system + y_coord = [coord for coord in ldd.coords if coord.startswith('lat') or coord.startswith('y')][0] + x_coord = [coord for coord in ldd.coords if coord.startswith('lon') or coord.startswith('x')][0] + + # spatial resolution of the input map + resolution = np.round(np.mean(np.diff(ldd[x_coord].values)), 4) + + # Define window around the input pixel + window = 1.5 * resolution + ldd_window = ldd.sel({y_coord: slice(lat + window, lat - window), + x_coord: slice(lon - window, lon + window)}) + # 2D arrays of the coordinates of the pixels in the window + lons, lats = np.meshgrid(ldd_window[x_coord].data, ldd_window[y_coord].data) + + # create a 1D mask of inflow pixels + inflow = np.array([[3, 2, 1], + [6, 5, 4], + [9, 8, 7]]) + mask = (ldd_window == inflow).data.flatten() + + # apply mask + lons, lats = lons.flatten()[mask], lats.flatten()[mask] + + # convert to xarray.Dataset + points = pd.DataFrame(data={y_coord: lats, x_coord: lons}) + points.index.name = 'inflow' + points = points.to_xarray() + + return points + + + +def extract_timeseries( + maps: xr.Dataset, + poi: xr.Dataset, + inflow: bool = False, + ldd: Optional[xr.Dataset] = None, + output: Optional[Union[str, Path]] = None, + overwrite: bool = False +) -> Optional[xr.Dataset]: + """Extracts time series for each point of interest and saves them separately. Parameters: ----------- maps: xarray.Dataset the time stack of input maps from which the time series will be extracted poi: xarray.Dataset - a Dataset indicating the coordinates of the points of interest. It must have only two variables (the coordinates), and the names of this variables must be dimensions in "maps" - ouputfile: optional, string or pathlib.Path - the file where the results will be saved. It can be either a CSV or a NetCDF file + A Dataset indicating the coordinates of the points of interest. It must have only two variables (the coordinates), and the names of this variables must be dimensions in "maps" + inflow: boolean + Wheter to extract the value in that pixel (False) or compute the sum of the pixels flowing into it (True) + ldd: optional, xarray.Dataset + Map of local drainage directions. Only needed if 'inflow' is True + output: optional, string or pathlib.Path + The directory where the results will be saved. If not provided, returns an xarray.Dataset. + overwrite: boolean + whether to overwrite or skip points of interest whose output file already exists. By default is False Returns: -------- - By default, it puts out an xarray.Dataset with the extracted time series. Instead, if "outputfile" is provided, results will be saved to a file (CSV or NetCDF) + If 'output' is None, returns an xarray.Dataset with extracted time series. + Otherwise, saves results in a set of NetCDF files. """ - + + if "id" not in poi.coords: + raise ValueError('ERROR: "poi" must contain an "id" coordinate.') + coord_1, coord_2 = list(poi) if not all(coord in maps.coords for coord in [coord_1, coord_2]): - print(f'ERROR: The variables in "poi" (coordinates) are not coordinates in "maps"') - sys.exit(1) - - # extract time series - maps_poi = maps.sel({coord_1: poi[coord_1], coord_2: poi[coord_2]}, method='nearest') - - if outputfile is None: - return maps_poi.compute() - + raise ValueError(f'The variables in "poi" (coordinates) are not coordinates in "maps"') + if coord_1.startswith('y') or coord_1.startswith('lat'): + coords = [coord_1, coord_2] else: - outputfile = Path(outputfile) - if outputfile.suffix == '.nc': - maps_poi.to_netcdf(outputfile) - elif outputfile.suffix == '.csv': - df = maps_poi.to_dataframe() - df_reset = df.reset_index() - df_reset.to_csv(outputfile, index=False) - else: - print('ERROR: the extension of the output file must be either ".nc" or ".csv"') - sys.exit(2) - print(f'Results exported as {outputfile}') - - + coords = [coord_2, coord_1] + + if inflow and ldd is None: + raise ValueError('An "ldd" map must be provided if the option "inflow" is enabled.') + + # create output directory + if output: + output = Path(output) + output.mkdir(parents=True, exist_ok=True) + + maps_poi = [] + for ID in poi.id.data: + + if output: + output_file = output / f'{ID}.nc' + if output_file.exists() and not overwrite: + print(f'Output file {output_file} already exists. Moving forward to the next point.') + continue + + if inflow: + # find pixels flowing into the point of interest + inflows = find_inflow_points(*[poi.sel(id=ID)[coord].item() for coord in coords], ldd) + + # extract and sum the time series of the pixels flowing into the point + series = maps.sel({coord: inflows[coord] for coord in coords}, method='nearest').sum('inflow') + series = series.expand_dims({'id': [ID]}) + series = series.assign_coords({coord: ('id', + [maps[coord].sel({coord: poi.sel(id=ID)[coord].item()}, method='nearest').item()]) + # [poi.sel(id=ID)[coord].item()]) + for coord in coords}) + series.attrs.update(maps.attrs) + else: + # extract time series of the point + series = maps.sel({coord: poi.sel(id=ID)[coord].item() for coord in coords}, method='nearest') + series = series.expand_dims(dim={'id': [ID]}) + + # save time series + if output is None: + maps_poi.append(series) + print('{0} | Time series for point {1} extracted'.format(datetime.now().strftime('%Y-%m-%d %H:%M:%S'), + ID)) + else: + series.to_netcdf(output_file) + print('{0} | Time series for point {1} saved in {2}'.format(datetime.now().strftime('%Y-%m-%d %H:%M'), + ID, + output_file)) + + if output is None: + return xr.concat(maps_poi, dim='id').compute() + + return None + + + def main(argv=sys.argv): prog = os.path.basename(argv[0]) parser = argparse.ArgumentParser( @@ -160,32 +356,64 @@ def main(argv=sys.argv): """, prog=prog, ) - parser.add_argument("-i", "--input", required=True, help="Input CSV file (id, lat, lon)") - parser.add_argument("-d", "--directory", required=True, help="Input directory with .nc files") - parser.add_argument("-o", "--output", required=True, help="Output file. Two extensions are supported: .csv or .nc") + parser.add_argument("-p", "--points", required=True, help="CSV file of points of interest (id, lat, lon)") + parser.add_argument("-d", "--dir", required=True, help="Input directory with NetCDF or GRIB files") + parser.add_argument("-o", "--output", required=True, help="Output directory for time series") + parser.add_argument("-s", "--start", type=str, default=None, help='Start datetime (YYYY-MM-DD) (default: None)') + parser.add_argument("-e", "--end", type=str, default=None, help='End datetime (YYYY-MM-DD) (default: None)') + parser.add_argument("-i", "--inflow", action="store_true", default=False, help='Extract the aggregation of pixels flowing into the points of interest') + parser.add_argument("-l", "--ldd", required=False, help="Map of local drainage directions. Only neccesary if 'inflow' is True") + parser.add_argument("-w", "--overwrite", action="store_true", default=False, help="Overwrite existing output files") args = parser.parse_args() - + + + # parse dates + if args.start: + try: + args.start = datetime.strptime(args.start, "%Y-%m-%d") + except ValueError: + raise ValueError("Invalid date format in the 'start' argument. Use 'YYYY-MM-DD'.") + if args.end: + try: + args.end = datetime.strptime(args.end, "%Y-%m-%d") + except ValueError: + raise ValueError("Invalid date format in the 'end' argument. Use 'YYYY-MM-DD'.") + try: - start_time = time.perf_counter() - print('Reading input CSV...') - points = read_points(args.input) + start_time = time.perf_counter() + print('Reading input maps...') - maps = read_inputmaps(args.directory) + maps = read_inputmaps(args.dir, start=args.start, end=args.end) print(maps) + + print('Reading input CSV...') + points = read_points(args.points) + points = rename_geographic_coords(points, maps) + + if args.inflow: + if args.ldd is None: + raise ValueError("-ldd must be provided if --inflow is enabled.") + else: + print('Reading the LDD map...') + ldd = read_ldd(args.ldd) + args.ldd = rename_geographic_coords(ldd, maps) + print('Processing...') - extract_timeseries(maps, points, args.output) + extract_timeseries(maps, points, args.inflow, args.ldd, args.output, args.overwrite) elapsed_time = time.perf_counter() - start_time print(f"Time elapsed: {elapsed_time:0.2f} seconds") except Exception as e: - print(f'ERROR: {e}') + raise RuntimeError(f'{e}') sys.exit(1) + + def main_script(): sys.exit(main()) if __name__ == "__main__": - main_script() + main_script() \ No newline at end of file diff --git a/tests/data/ncextract/datasets/dis24_2018.nc b/tests/data/ncextract/datasets/dis24_2018.nc new file mode 100644 index 0000000..30fc43b Binary files /dev/null and b/tests/data/ncextract/datasets/dis24_2018.nc differ diff --git a/tests/data/ncextract/datasets/dis24_2019.nc b/tests/data/ncextract/datasets/dis24_2019.nc new file mode 100644 index 0000000..ab6dfa1 Binary files /dev/null and b/tests/data/ncextract/datasets/dis24_2019.nc differ diff --git a/tests/data/ncextract/datasets/rsfil_2019.nc b/tests/data/ncextract/datasets/rsfil_2019.nc deleted file mode 100644 index aee75cc..0000000 Binary files a/tests/data/ncextract/datasets/rsfil_2019.nc and /dev/null differ diff --git a/tests/data/ncextract/datasets/rsfil_2020.nc b/tests/data/ncextract/datasets/rsfil_2020.nc deleted file mode 100644 index 14602ec..0000000 Binary files a/tests/data/ncextract/datasets/rsfil_2020.nc and /dev/null differ diff --git a/tests/data/ncextract/expected.csv b/tests/data/ncextract/expected.csv deleted file mode 100644 index 2275b45..0000000 --- a/tests/data/ncextract/expected.csv +++ /dev/null @@ -1,5841 +0,0 @@ -id,time,lon,lat,rsfil -14,2018-01-02,-109.22500000000001,44.475,0.968578051886524 -14,2018-01-03,-109.22500000000001,44.475,0.9685774981435288 -14,2018-01-04,-109.22500000000001,44.475,0.9685769444005334 -14,2018-01-05,-109.22500000000001,44.475,0.9685763906575382 -14,2018-01-06,-109.22500000000001,44.475,0.9685758369145429 -14,2018-01-07,-109.22500000000001,44.475,0.9685752831715476 -14,2018-01-08,-109.22500000000001,44.475,0.9685747294285523 -14,2018-01-09,-109.22500000000001,44.475,0.968574175685557 -14,2018-01-10,-109.22500000000001,44.475,0.9685736219425618 -14,2018-01-11,-109.22500000000001,44.475,0.9685730681995665 -14,2018-01-12,-109.22500000000001,44.475,0.9685725144565712 -14,2018-01-13,-109.22500000000001,44.475,0.9685719607135759 -14,2018-01-14,-109.22500000000001,44.475,0.9685714069705806 -14,2018-01-15,-109.22500000000001,44.475,0.9685708532275853 -14,2018-01-16,-109.22500000000001,44.475,0.9685702994845901 -14,2018-01-17,-109.22500000000001,44.475,0.9685697457415947 -14,2018-01-18,-109.22500000000001,44.475,0.9685691919985995 -14,2018-01-19,-109.22500000000001,44.475,0.9685686382556041 -14,2018-01-20,-109.22500000000001,44.475,0.9685680845126089 -14,2018-01-21,-109.22500000000001,44.475,0.9685675307696137 -14,2018-01-22,-109.22500000000001,44.475,0.9685669770266183 -14,2018-01-23,-109.22500000000001,44.475,0.9685664232836231 -14,2018-01-24,-109.22500000000001,44.475,0.9685658695406277 -14,2018-01-25,-109.22500000000001,44.475,0.9685653157976325 -14,2018-01-26,-109.22500000000001,44.475,0.9685647620546372 -14,2018-01-27,-109.22500000000001,44.475,0.9685642083116419 -14,2018-01-28,-109.22500000000001,44.475,0.9685636545686466 -14,2018-01-29,-109.22500000000001,44.475,0.9685631008256513 -14,2018-01-30,-109.22500000000001,44.475,0.9685625470826561 -14,2018-01-31,-109.22500000000001,44.475,0.9685619933396608 -14,2018-02-01,-109.22500000000001,44.475,0.9685614395966655 -14,2018-02-02,-109.22500000000001,44.475,0.9685608892338967 -14,2018-02-03,-109.22500000000001,44.475,0.9685603388711279 -14,2018-02-04,-109.22500000000001,44.475,0.9685597885083592 -14,2018-02-05,-109.22500000000001,44.475,0.9685592381455904 -14,2018-02-06,-109.22500000000001,44.475,0.9685586877828216 -14,2018-02-07,-109.22500000000001,44.475,0.9685581374200528 -14,2018-02-08,-109.22500000000001,44.475,0.9685575870572841 -14,2018-02-09,-109.22500000000001,44.475,0.9685570366945153 -14,2018-02-10,-109.22500000000001,44.475,0.9685564863317465 -14,2018-02-11,-109.22500000000001,44.475,0.9685559359689778 -14,2018-02-12,-109.22500000000001,44.475,0.968555385606209 -14,2018-02-13,-109.22500000000001,44.475,0.9685548352434402 -14,2018-02-14,-109.22500000000001,44.475,0.9685542848806715 -14,2018-02-15,-109.22500000000001,44.475,0.9685537345179027 -14,2018-02-16,-109.22500000000001,44.475,0.9685531841551339 -14,2018-02-17,-109.22500000000001,44.475,0.9685526337923652 -14,2018-02-18,-109.22500000000001,44.475,0.9685520834295964 -14,2018-02-19,-109.22500000000001,44.475,0.9685515330668276 -14,2018-02-20,-109.22500000000001,44.475,0.9685509827040588 -14,2018-02-21,-109.22500000000001,44.475,0.9685504323412901 -14,2018-02-22,-109.22500000000001,44.475,0.9685498819785213 -14,2018-02-23,-109.22500000000001,44.475,0.9685493316157525 -14,2018-02-24,-109.22500000000001,44.475,0.9685487812529838 -14,2018-02-25,-109.22500000000001,44.475,0.968548230890215 -14,2018-02-26,-109.22500000000001,44.475,0.9685476805274462 -14,2018-02-27,-109.22500000000001,44.475,0.9685471301646775 -14,2018-02-28,-109.22500000000001,44.475,0.9685465798019087 -14,2018-03-01,-109.22500000000001,44.475,0.9685460294391399 -14,2018-03-02,-109.22500000000001,44.475,0.9685454151275815 -14,2018-03-03,-109.22500000000001,44.475,0.968544800816023 -14,2018-03-04,-109.22500000000001,44.475,0.9685441865044645 -14,2018-03-05,-109.22500000000001,44.475,0.9685435721929061 -14,2018-03-06,-109.22500000000001,44.475,0.9685429578813476 -14,2018-03-07,-109.22500000000001,44.475,0.9685423435697892 -14,2018-03-08,-109.22500000000001,44.475,0.9685417292582307 -14,2018-03-09,-109.22500000000001,44.475,0.9685411149466722 -14,2018-03-10,-109.22500000000001,44.475,0.9685405006351138 -14,2018-03-11,-109.22500000000001,44.475,0.9685398863235553 -14,2018-03-12,-109.22500000000001,44.475,0.9685392720119969 -14,2018-03-13,-109.22500000000001,44.475,0.9685386577004383 -14,2018-03-14,-109.22500000000001,44.475,0.9685380433888798 -14,2018-03-15,-109.22500000000001,44.475,0.9685374290773214 -14,2018-03-16,-109.22500000000001,44.475,0.9685368147657629 -14,2018-03-17,-109.22500000000001,44.475,0.9685362004542045 -14,2018-03-18,-109.22500000000001,44.475,0.968535586142646 -14,2018-03-19,-109.22500000000001,44.475,0.9685349718310875 -14,2018-03-20,-109.22500000000001,44.475,0.9685343575195291 -14,2018-03-21,-109.22500000000001,44.475,0.9685337432079706 -14,2018-03-22,-109.22500000000001,44.475,0.9685331288964122 -14,2018-03-23,-109.22500000000001,44.475,0.9685325145848537 -14,2018-03-24,-109.22500000000001,44.475,0.9685319002732952 -14,2018-03-25,-109.22500000000001,44.475,0.9685312859617368 -14,2018-03-26,-109.22500000000001,44.475,0.9685306716501783 -14,2018-03-27,-109.22500000000001,44.475,0.9685300573386199 -14,2018-03-28,-109.22500000000001,44.475,0.9685294430270613 -14,2018-03-29,-109.22500000000001,44.475,0.9685288287155028 -14,2018-03-30,-109.22500000000001,44.475,0.9685282144039444 -14,2018-03-31,-109.22500000000001,44.475,0.9685276000923859 -14,2018-04-01,-109.22500000000001,44.475,0.9685269857808275 -14,2018-04-02,-109.22500000000001,44.475,0.9685263256013934 -14,2018-04-03,-109.22500000000001,44.475,0.9685256654219594 -14,2018-04-04,-109.22500000000001,44.475,0.9685250052425254 -14,2018-04-05,-109.22500000000001,44.475,0.9685243450630914 -14,2018-04-06,-109.22500000000001,44.475,0.9685236848836574 -14,2018-04-07,-109.22500000000001,44.475,0.9685230247042232 -14,2018-04-08,-109.22500000000001,44.475,0.9685223645247892 -14,2018-04-09,-109.22500000000001,44.475,0.9685217043453552 -14,2018-04-10,-109.22500000000001,44.475,0.9685210441659212 -14,2018-04-11,-109.22500000000001,44.475,0.9685203839864872 -14,2018-04-12,-109.22500000000001,44.475,0.9685197238070532 -14,2018-04-13,-109.22500000000001,44.475,0.9685190636276191 -14,2018-04-14,-109.22500000000001,44.475,0.9685184034481851 -14,2018-04-15,-109.22500000000001,44.475,0.9685177432687511 -14,2018-04-16,-109.22500000000001,44.475,0.968517083089317 -14,2018-04-17,-109.22500000000001,44.475,0.968516422909883 -14,2018-04-18,-109.22500000000001,44.475,0.9685157627304489 -14,2018-04-19,-109.22500000000001,44.475,0.9685151025510149 -14,2018-04-20,-109.22500000000001,44.475,0.9685144423715809 -14,2018-04-21,-109.22500000000001,44.475,0.9685137821921469 -14,2018-04-22,-109.22500000000001,44.475,0.9685131220127129 -14,2018-04-23,-109.22500000000001,44.475,0.9685124618332789 -14,2018-04-24,-109.22500000000001,44.475,0.9685118016538448 -14,2018-04-25,-109.22500000000001,44.475,0.9685111414744108 -14,2018-04-26,-109.22500000000001,44.475,0.9685104812949767 -14,2018-04-27,-109.22500000000001,44.475,0.9685098211155427 -14,2018-04-28,-109.22500000000001,44.475,0.9685091609361087 -14,2018-04-29,-109.22500000000001,44.475,0.9685085007566746 -14,2018-04-30,-109.22500000000001,44.475,0.9685078405772406 -14,2018-05-01,-109.22500000000001,44.475,0.9685071803978066 -14,2018-05-02,-109.22500000000001,44.475,0.9679570604555949 -14,2018-05-03,-109.22500000000001,44.475,0.9671630785979932 -14,2018-05-04,-109.22500000000001,44.475,0.966390531846226 -14,2018-05-05,-109.22500000000001,44.475,0.9656254312106541 -14,2018-05-06,-109.22500000000001,44.475,0.9649688338958669 -14,2018-05-07,-109.22500000000001,44.475,0.9645053466259802 -14,2018-05-08,-109.22500000000001,44.475,0.9643548341245419 -14,2018-05-09,-109.22500000000001,44.475,0.9645940632213027 -14,2018-05-10,-109.22500000000001,44.475,0.9651485410353974 -14,2018-05-11,-109.22500000000001,44.475,0.9659931117227533 -14,2018-05-12,-109.22500000000001,44.475,0.9672402562340509 -14,2018-05-13,-109.22500000000001,44.475,0.9688311826621361 -14,2018-05-14,-109.22500000000001,44.475,0.9703651130327794 -14,2018-05-15,-109.22500000000001,44.475,0.9717771472115861 -14,2018-05-16,-109.22500000000001,44.475,0.9730979422992562 -14,2018-05-17,-109.22500000000001,44.475,0.9744140128281378 -14,2018-05-18,-109.22500000000001,44.475,0.9758751700446329 -14,2018-05-19,-109.22500000000001,44.475,0.9776447902597515 -14,2018-05-20,-109.22500000000001,44.475,0.9796821119162077 -14,2018-05-21,-109.22500000000001,44.475,0.9817828849823107 -14,2018-05-22,-109.22500000000001,44.475,0.9839688337433814 -14,2018-05-23,-109.22500000000001,44.475,0.9857666842287539 -14,2018-05-24,-109.22500000000001,44.475,0.9867426255423659 -14,2018-05-25,-109.22500000000001,44.475,0.9874520119268593 -14,2018-05-26,-109.22500000000001,44.475,0.9880372102675159 -14,2018-05-27,-109.22500000000001,44.475,0.9884962678205839 -14,2018-05-28,-109.22500000000001,44.475,0.9890942671117854 -14,2018-05-29,-109.22500000000001,44.475,0.9898573572271168 -14,2018-05-30,-109.22500000000001,44.475,0.9904785820222602 -14,2018-05-31,-109.22500000000001,44.475,0.9908839728729255 -14,2018-06-01,-109.22500000000001,44.475,0.9911631136536554 -14,2018-06-02,-109.22500000000001,44.475,0.9915441993275442 -14,2018-06-03,-109.22500000000001,44.475,0.9917958377532033 -14,2018-06-04,-109.22500000000001,44.475,0.9917526423299495 -14,2018-06-05,-109.22500000000001,44.475,0.9918849908855711 -14,2018-06-06,-109.22500000000001,44.475,0.9928836722058214 -14,2018-06-07,-109.22500000000001,44.475,0.9943763178322838 -14,2018-06-08,-109.22500000000001,44.475,0.9955968547628724 -14,2018-06-09,-109.22500000000001,44.475,0.99695132215652 -14,2018-06-10,-109.22500000000001,44.475,0.9987748921412569 -14,2018-06-11,-109.22500000000001,44.475,0.9997620251753355 -14,2018-06-12,-109.22500000000001,44.475,0.9998846026958751 -14,2018-06-13,-109.22500000000001,44.475,0.9995405155005646 -14,2018-06-14,-109.22500000000001,44.475,0.9990170362648224 -14,2018-06-15,-109.22500000000001,44.475,0.999504787203579 -14,2018-06-16,-109.22500000000001,44.475,0.9999101869483111 -14,2018-06-17,-109.22500000000001,44.475,0.9999841968771253 -14,2018-06-18,-109.22500000000001,44.475,1.0 -14,2018-06-19,-109.22500000000001,44.475,1.0 -14,2018-06-20,-109.22500000000001,44.475,1.0 -14,2018-06-21,-109.22500000000001,44.475,1.0 -14,2018-06-22,-109.22500000000001,44.475,1.0 -14,2018-06-23,-109.22500000000001,44.475,1.0 -14,2018-06-24,-109.22500000000001,44.475,1.0 -14,2018-06-25,-109.22500000000001,44.475,1.0 -14,2018-06-26,-109.22500000000001,44.475,1.0 -14,2018-06-27,-109.22500000000001,44.475,1.0 -14,2018-06-28,-109.22500000000001,44.475,0.9999944467258239 -14,2018-06-29,-109.22500000000001,44.475,0.9997490773600193 -14,2018-06-30,-109.22500000000001,44.475,0.999385701781511 -14,2018-07-01,-109.22500000000001,44.475,0.9989672702989231 -14,2018-07-02,-109.22500000000001,44.475,0.9985291772819265 -14,2018-07-03,-109.22500000000001,44.475,0.9980200020989615 -14,2018-07-04,-109.22500000000001,44.475,0.997481327093626 -14,2018-07-05,-109.22500000000001,44.475,0.9969627763590377 -14,2018-07-06,-109.22500000000001,44.475,0.996466554860786 -14,2018-07-07,-109.22500000000001,44.475,0.9959923207752474 -14,2018-07-08,-109.22500000000001,44.475,0.9955174864218778 -14,2018-07-09,-109.22500000000001,44.475,0.9950469622109546 -14,2018-07-10,-109.22500000000001,44.475,0.9945972098191456 -14,2018-07-11,-109.22500000000001,44.475,0.994158037687864 -14,2018-07-12,-109.22500000000001,44.475,0.9937231699618899 -14,2018-07-13,-109.22500000000001,44.475,0.9933053829388373 -14,2018-07-14,-109.22500000000001,44.475,0.992894753053799 -14,2018-07-15,-109.22500000000001,44.475,0.9925098977349563 -14,2018-07-16,-109.22500000000001,44.475,0.9921366902556177 -14,2018-07-17,-109.22500000000001,44.475,0.9918229790196039 -14,2018-07-18,-109.22500000000001,44.475,0.9914962217642458 -14,2018-07-19,-109.22500000000001,44.475,0.9911675110348199 -14,2018-07-20,-109.22500000000001,44.475,0.9908477733235243 -14,2018-07-21,-109.22500000000001,44.475,0.990533340103948 -14,2018-07-22,-109.22500000000001,44.475,0.9902481880002572 -14,2018-07-23,-109.22500000000001,44.475,0.9899485687022834 -14,2018-07-24,-109.22500000000001,44.475,0.9896631754557468 -14,2018-07-25,-109.22500000000001,44.475,0.989400519491443 -14,2018-07-26,-109.22500000000001,44.475,0.989152190246653 -14,2018-07-27,-109.22500000000001,44.475,0.9889391193708945 -14,2018-07-28,-109.22500000000001,44.475,0.988751461048651 -14,2018-07-29,-109.22500000000001,44.475,0.9885528849133628 -14,2018-07-30,-109.22500000000001,44.475,0.988354872533796 -14,2018-07-31,-109.22500000000001,44.475,0.9881587726879739 -14,2018-08-01,-109.22500000000001,44.475,0.9879618576384042 -14,2018-08-02,-109.22500000000001,44.475,0.9877612002174759 -14,2018-08-03,-109.22500000000001,44.475,0.9875714073863633 -14,2018-08-04,-109.22500000000001,44.475,0.987404314082831 -14,2018-08-05,-109.22500000000001,44.475,0.9872370313048796 -14,2018-08-06,-109.22500000000001,44.475,0.9871090721164629 -14,2018-08-07,-109.22500000000001,44.475,0.9869547327603895 -14,2018-08-08,-109.22500000000001,44.475,0.9867980469280777 -14,2018-08-09,-109.22500000000001,44.475,0.986639480723872 -14,2018-08-10,-109.22500000000001,44.475,0.9864878756383353 -14,2018-08-11,-109.22500000000001,44.475,0.9863366488077143 -14,2018-08-12,-109.22500000000001,44.475,0.9861966757932097 -14,2018-08-13,-109.22500000000001,44.475,0.9860724566184819 -14,2018-08-14,-109.22500000000001,44.475,0.9859537210130497 -14,2018-08-15,-109.22500000000001,44.475,0.9858428323713202 -14,2018-08-16,-109.22500000000001,44.475,0.98573059527251 -14,2018-08-17,-109.22500000000001,44.475,0.9856217629720175 -14,2018-08-18,-109.22500000000001,44.475,0.9855149076254226 -14,2018-08-19,-109.22500000000001,44.475,0.9854562607404915 -14,2018-08-20,-109.22500000000001,44.475,0.9853782766242203 -14,2018-08-21,-109.22500000000001,44.475,0.9853295188615188 -14,2018-08-22,-109.22500000000001,44.475,0.9852660149625247 -14,2018-08-23,-109.22500000000001,44.475,0.9851879602579343 -14,2018-08-24,-109.22500000000001,44.475,0.9851090889262158 -14,2018-08-25,-109.22500000000001,44.475,0.9850342083595056 -14,2018-08-26,-109.22500000000001,44.475,0.9849607499870233 -14,2018-08-27,-109.22500000000001,44.475,0.9848871893858672 -14,2018-08-28,-109.22500000000001,44.475,0.9848732212344363 -14,2018-08-29,-109.22500000000001,44.475,0.9848927583657303 -14,2018-08-30,-109.22500000000001,44.475,0.9848315234166564 -14,2018-08-31,-109.22500000000001,44.475,0.9847542244103255 -14,2018-09-01,-109.22500000000001,44.475,0.9847018155058 -14,2018-09-02,-109.22500000000001,44.475,0.9846408373238015 -14,2018-09-03,-109.22500000000001,44.475,0.984565318749286 -14,2018-09-04,-109.22500000000001,44.475,0.9844301497673804 -14,2018-09-05,-109.22500000000001,44.475,0.984237159903869 -14,2018-09-06,-109.22500000000001,44.475,0.9839932530518928 -14,2018-09-07,-109.22500000000001,44.475,0.9836944201184532 -14,2018-09-08,-109.22500000000001,44.475,0.9833401883172602 -14,2018-09-09,-109.22500000000001,44.475,0.9829495578478088 -14,2018-09-10,-109.22500000000001,44.475,0.982506164939729 -14,2018-09-11,-109.22500000000001,44.475,0.9820100323528383 -14,2018-09-12,-109.22500000000001,44.475,0.9814836998452962 -14,2018-09-13,-109.22500000000001,44.475,0.980923955347113 -14,2018-09-14,-109.22500000000001,44.475,0.9803273112099515 -14,2018-09-15,-109.22500000000001,44.475,0.979691013755833 -14,2018-09-16,-109.22500000000001,44.475,0.9790147899001778 -14,2018-09-17,-109.22500000000001,44.475,0.9782984174016802 -14,2018-09-18,-109.22500000000001,44.475,0.9775519438265043 -14,2018-09-19,-109.22500000000001,44.475,0.9767764339371137 -14,2018-09-20,-109.22500000000001,44.475,0.9759783206970453 -14,2018-09-21,-109.22500000000001,44.475,0.9752175760775473 -14,2018-09-22,-109.22500000000001,44.475,0.9744170949263405 -14,2018-09-23,-109.22500000000001,44.475,0.9735614814545511 -14,2018-09-24,-109.22500000000001,44.475,0.9726800195617836 -14,2018-09-25,-109.22500000000001,44.475,0.9718670933584146 -14,2018-09-26,-109.22500000000001,44.475,0.9710053455256628 -14,2018-09-27,-109.22500000000001,44.475,0.9700891861807607 -14,2018-09-28,-109.22500000000001,44.475,0.9691745584532698 -14,2018-09-29,-109.22500000000001,44.475,0.969173752744958 -14,2018-09-30,-109.22500000000001,44.475,0.9691729470366461 -14,2018-10-01,-109.22500000000001,44.475,0.9691721413283344 -14,2018-10-02,-109.22500000000001,44.475,0.9691714862616413 -14,2018-10-03,-109.22500000000001,44.475,0.9691708311949482 -14,2018-10-04,-109.22500000000001,44.475,0.9691701761282552 -14,2018-10-05,-109.22500000000001,44.475,0.9691695210615621 -14,2018-10-06,-109.22500000000001,44.475,0.9687289200854349 -14,2018-10-07,-109.22500000000001,44.475,0.9678880222874057 -14,2018-10-08,-109.22500000000001,44.475,0.9671412140421537 -14,2018-10-09,-109.22500000000001,44.475,0.9664580898489402 -14,2018-10-10,-109.22500000000001,44.475,0.9658467055965974 -14,2018-10-11,-109.22500000000001,44.475,0.9652993500184822 -14,2018-10-12,-109.22500000000001,44.475,0.9648139428319983 -14,2018-10-13,-109.22500000000001,44.475,0.9643753002663912 -14,2018-10-14,-109.22500000000001,44.475,0.96400421826031 -14,2018-10-15,-109.22500000000001,44.475,0.9636664614594603 -14,2018-10-16,-109.22500000000001,44.475,0.9633579412591847 -14,2018-10-17,-109.22500000000001,44.475,0.9630765666397977 -14,2018-10-18,-109.22500000000001,44.475,0.9628200710430342 -14,2018-10-19,-109.22500000000001,44.475,0.9626006501512927 -14,2018-10-20,-109.22500000000001,44.475,0.9625026988829917 -14,2018-10-21,-109.22500000000001,44.475,0.962414894777582 -14,2018-10-22,-109.22500000000001,44.475,0.9622750257725515 -14,2018-10-23,-109.22500000000001,44.475,0.9621232288569052 -14,2018-10-24,-109.22500000000001,44.475,0.9619828770600329 -14,2018-10-25,-109.22500000000001,44.475,0.9618509661575364 -14,2018-10-26,-109.22500000000001,44.475,0.9617360592951137 -14,2018-10-27,-109.22500000000001,44.475,0.9616344156409468 -14,2018-10-28,-109.22500000000001,44.475,0.9615739965566997 -14,2018-10-29,-109.22500000000001,44.475,0.9614993190848645 -14,2018-10-30,-109.22500000000001,44.475,0.961460531042528 -14,2018-10-31,-109.22500000000001,44.475,0.9614214315841326 -14,2018-11-01,-109.22500000000001,44.475,0.9613702461729753 -14,2018-11-02,-109.22500000000001,44.475,0.9613125979497134 -14,2018-11-03,-109.22500000000001,44.475,0.9612767700406375 -14,2018-11-04,-109.22500000000001,44.475,0.9612422589413162 -14,2018-11-05,-109.22500000000001,44.475,0.9612152064201924 -14,2018-11-06,-109.22500000000001,44.475,0.961170573495739 -14,2018-11-07,-109.22500000000001,44.475,0.9611193722202374 -14,2018-11-08,-109.22500000000001,44.475,0.9610623894629516 -14,2018-11-09,-109.22500000000001,44.475,0.9610006292212856 -14,2018-11-10,-109.22500000000001,44.475,0.960939352246544 -14,2018-11-11,-109.22500000000001,44.475,0.9608764306190758 -14,2018-11-12,-109.22500000000001,44.475,0.960817753133645 -14,2018-11-13,-109.22500000000001,44.475,0.9607595038082151 -14,2018-11-14,-109.22500000000001,44.475,0.9606996304452431 -14,2018-11-15,-109.22500000000001,44.475,0.9606414817446915 -14,2018-11-16,-109.22500000000001,44.475,0.9605840092591142 -14,2018-11-17,-109.22500000000001,44.475,0.9605373948718022 -14,2018-11-18,-109.22500000000001,44.475,0.9604872837907186 -14,2018-11-19,-109.22500000000001,44.475,0.9604393614499291 -14,2018-11-20,-109.22500000000001,44.475,0.9603914654212908 -14,2018-11-21,-109.22500000000001,44.475,0.9603420179040338 -14,2018-11-22,-109.22500000000001,44.475,0.9602917414696084 -14,2018-11-23,-109.22500000000001,44.475,0.960244842112857 -14,2018-11-24,-109.22500000000001,44.475,0.9601966040667669 -14,2018-11-25,-109.22500000000001,44.475,0.9601561157028156 -14,2018-11-26,-109.22500000000001,44.475,0.9601158256535091 -14,2018-11-27,-109.22500000000001,44.475,0.9600724356932613 -14,2018-11-28,-109.22500000000001,44.475,0.9600297433780163 -14,2018-11-29,-109.22500000000001,44.475,0.9599837495803096 -14,2018-11-30,-109.22500000000001,44.475,0.9599380618027556 -14,2018-12-01,-109.22500000000001,44.475,0.9598999020361861 -14,2018-12-02,-109.22500000000001,44.475,0.9598609136402184 -14,2018-12-03,-109.22500000000001,44.475,0.9598228869580172 -14,2018-12-04,-109.22500000000001,44.475,0.9597871371960527 -14,2018-12-05,-109.22500000000001,44.475,0.9597491977421003 -14,2018-12-06,-109.22500000000001,44.475,0.9597106993610784 -14,2018-12-07,-109.22500000000001,44.475,0.9596702456872775 -14,2018-12-08,-109.22500000000001,44.475,0.9596279509607263 -14,2018-12-09,-109.22500000000001,44.475,0.9595774031861698 -14,2018-12-10,-109.22500000000001,44.475,0.9595314569264466 -14,2018-12-11,-109.22500000000001,44.475,0.9594878265318468 -14,2018-12-12,-109.22500000000001,44.475,0.9594397271928695 -14,2018-12-13,-109.22500000000001,44.475,0.9593952840689004 -14,2018-12-14,-109.22500000000001,44.475,0.9593554178147169 -14,2018-12-15,-109.22500000000001,44.475,0.9593144487627923 -14,2018-12-16,-109.22500000000001,44.475,0.9592700216485857 -14,2018-12-17,-109.22500000000001,44.475,0.9592222372498418 -14,2018-12-18,-109.22500000000001,44.475,0.9591754569171334 -14,2018-12-19,-109.22500000000001,44.475,0.9591630132116227 -14,2018-12-20,-109.22500000000001,44.475,0.9591447813663527 -14,2018-12-21,-109.22500000000001,44.475,0.9591128651730024 -14,2018-12-22,-109.22500000000001,44.475,0.9590713924173606 -14,2018-12-23,-109.22500000000001,44.475,0.9590234002455004 -14,2018-12-24,-109.22500000000001,44.475,0.9589782317160574 -14,2018-12-25,-109.22500000000001,44.475,0.9589310092075185 -14,2018-12-26,-109.22500000000001,44.475,0.9588857083897055 -14,2018-12-27,-109.22500000000001,44.475,0.9588372468074978 -14,2018-12-28,-109.22500000000001,44.475,0.9587920070935291 -14,2018-12-29,-109.22500000000001,44.475,0.9587489293142182 -14,2018-12-30,-109.22500000000001,44.475,0.9587057079846348 -14,2018-12-31,-109.22500000000001,44.475,0.9586573295886412 -14,2019-01-01,-109.22500000000001,44.475,0.9586100730590961 -14,2019-01-02,-109.22500000000001,44.475,0.9585672149293492 -14,2019-01-03,-109.22500000000001,44.475,0.9585222157885476 -14,2019-01-04,-109.22500000000001,44.475,0.9584766569765624 -14,2019-01-05,-109.22500000000001,44.475,0.9584251119083753 -14,2019-01-06,-109.22500000000001,44.475,0.9583724490319273 -14,2019-01-07,-109.22500000000001,44.475,0.9583189275471261 -14,2019-01-08,-109.22500000000001,44.475,0.9582732270842023 -14,2019-01-09,-109.22500000000001,44.475,0.958230321943884 -14,2019-01-10,-109.22500000000001,44.475,0.9581818631425583 -14,2019-01-11,-109.22500000000001,44.475,0.9581382861634946 -14,2019-01-12,-109.22500000000001,44.475,0.9580879228204721 -14,2019-01-13,-109.22500000000001,44.475,0.9580418011333727 -14,2019-01-14,-109.22500000000001,44.475,0.9579984950703632 -14,2019-01-15,-109.22500000000001,44.475,0.9579534611712796 -14,2019-01-16,-109.22500000000001,44.475,0.9579103479068185 -14,2019-01-17,-109.22500000000001,44.475,0.9578666086615252 -14,2019-01-18,-109.22500000000001,44.475,0.957820556305941 -14,2019-01-19,-109.22500000000001,44.475,0.9577744964020606 -14,2019-01-20,-109.22500000000001,44.475,0.9577300737085637 -14,2019-01-21,-109.22500000000001,44.475,0.9578094613869301 -14,2019-01-22,-109.22500000000001,44.475,0.9578592296435375 -14,2019-01-23,-109.22500000000001,44.475,0.9578326929677013 -14,2019-01-24,-109.22500000000001,44.475,0.9577799056974603 -14,2019-01-25,-109.22500000000001,44.475,0.9577206223392164 -14,2019-01-26,-109.22500000000001,44.475,0.9576576260890836 -14,2019-01-27,-109.22500000000001,44.475,0.9575908932671393 -14,2019-01-28,-109.22500000000001,44.475,0.9575605142214122 -14,2019-01-29,-109.22500000000001,44.475,0.9575255585662567 -14,2019-01-30,-109.22500000000001,44.475,0.9574768454529876 -14,2019-01-31,-109.22500000000001,44.475,0.9574234939939249 -14,2019-02-01,-109.22500000000001,44.475,0.9573616208999612 -14,2019-02-02,-109.22500000000001,44.475,0.9572940691412494 -14,2019-02-03,-109.22500000000001,44.475,0.9572282289763138 -14,2019-02-04,-109.22500000000001,44.475,0.9571649265812249 -14,2019-02-05,-109.22500000000001,44.475,0.95711143031423 -14,2019-02-06,-109.22500000000001,44.475,0.9570620451001881 -14,2019-02-07,-109.22500000000001,44.475,0.9570163059229809 -14,2019-02-08,-109.22500000000001,44.475,0.9569719417376586 -14,2019-02-09,-109.22500000000001,44.475,0.956926257094316 -14,2019-02-10,-109.22500000000001,44.475,0.9568795273024436 -14,2019-02-11,-109.22500000000001,44.475,0.9568330633261065 -14,2019-02-12,-109.22500000000001,44.475,0.9567821006982431 -14,2019-02-13,-109.22500000000001,44.475,0.9567228855060992 -14,2019-02-14,-109.22500000000001,44.475,0.9566624495749645 -14,2019-02-15,-109.22500000000001,44.475,0.9566074793267363 -14,2019-02-16,-109.22500000000001,44.475,0.9565489402559422 -14,2019-02-17,-109.22500000000001,44.475,0.9564959344416372 -14,2019-02-18,-109.22500000000001,44.475,0.9564505915976688 -14,2019-02-19,-109.22500000000001,44.475,0.9564108666601818 -14,2019-02-20,-109.22500000000001,44.475,0.9563700888264324 -14,2019-02-21,-109.22500000000001,44.475,0.9563289560661229 -14,2019-02-22,-109.22500000000001,44.475,0.9562830666773358 -14,2019-02-23,-109.22500000000001,44.475,0.9562399989575321 -14,2019-02-24,-109.22500000000001,44.475,0.9561927166132052 -14,2019-02-25,-109.22500000000001,44.475,0.9561473130076021 -14,2019-02-26,-109.22500000000001,44.475,0.9561045521131776 -14,2019-02-27,-109.22500000000001,44.475,0.956058099005287 -14,2019-02-28,-109.22500000000001,44.475,0.9560078925337854 -14,2019-03-01,-109.22500000000001,44.475,0.9559529693090172 -14,2019-03-02,-109.22500000000001,44.475,0.9558981515371504 -14,2019-03-03,-109.22500000000001,44.475,0.955857285917233 -14,2019-03-04,-109.22500000000001,44.475,0.955822494913697 -14,2019-03-05,-109.22500000000001,44.475,0.9557849594118103 -14,2019-03-06,-109.22500000000001,44.475,0.9557420438216467 -14,2019-03-07,-109.22500000000001,44.475,0.9556923878564579 -14,2019-03-08,-109.22500000000001,44.475,0.9556340890389633 -14,2019-03-09,-109.22500000000001,44.475,0.9555789922691326 -14,2019-03-10,-109.22500000000001,44.475,0.9555267482168641 -14,2019-03-11,-109.22500000000001,44.475,0.9554775368798694 -14,2019-03-12,-109.22500000000001,44.475,0.9554282389013543 -14,2019-03-13,-109.22500000000001,44.475,0.9553742225734065 -14,2019-03-14,-109.22500000000001,44.475,0.9553288748388201 -14,2019-03-15,-109.22500000000001,44.475,0.9552791683615282 -14,2019-03-16,-109.22500000000001,44.475,0.9552263027482337 -14,2019-03-17,-109.22500000000001,44.475,0.9551694026959193 -14,2019-03-18,-109.22500000000001,44.475,0.9551167165133091 -14,2019-03-19,-109.22500000000001,44.475,0.955063575203133 -14,2019-03-20,-109.22500000000001,44.475,0.9550114797970859 -14,2019-03-21,-109.22500000000001,44.475,0.9549573296564914 -14,2019-03-22,-109.22500000000001,44.475,0.9549102402640336 -14,2019-03-23,-109.22500000000001,44.475,0.9550023827380061 -14,2019-03-24,-109.22500000000001,44.475,0.9553389445766214 -14,2019-03-25,-109.22500000000001,44.475,0.9556660111447293 -14,2019-03-26,-109.22500000000001,44.475,0.9559279345706634 -14,2019-03-27,-109.22500000000001,44.475,0.9560640554486276 -14,2019-03-28,-109.22500000000001,44.475,0.9561597054321227 -14,2019-03-29,-109.22500000000001,44.475,0.9562319162984824 -14,2019-03-30,-109.22500000000001,44.475,0.9562593963912032 -14,2019-03-31,-109.22500000000001,44.475,0.9562233045723444 -14,2019-04-01,-109.22500000000001,44.475,0.9561300868639669 -14,2019-04-02,-109.22500000000001,44.475,0.9560164803074869 -14,2019-04-03,-109.22500000000001,44.475,0.9559007539614377 -14,2019-04-04,-109.22500000000001,44.475,0.9558325589406735 -14,2019-04-05,-109.22500000000001,44.475,0.9558625443892359 -14,2019-04-06,-109.22500000000001,44.475,0.9559089857664292 -14,2019-04-07,-109.22500000000001,44.475,0.9560151237664759 -14,2019-04-08,-109.22500000000001,44.475,0.9561804606755103 -14,2019-04-09,-109.22500000000001,44.475,0.9563633482080535 -14,2019-04-10,-109.22500000000001,44.475,0.9566571997977789 -14,2019-04-11,-109.22500000000001,44.475,0.9572213203794572 -14,2019-04-12,-109.22500000000001,44.475,0.9577758194480787 -14,2019-04-13,-109.22500000000001,44.475,0.9581180656521252 -14,2019-04-14,-109.22500000000001,44.475,0.9582884006161232 -14,2019-04-15,-109.22500000000001,44.475,0.9583836063385052 -14,2019-04-16,-109.22500000000001,44.475,0.9584562743073634 -14,2019-04-17,-109.22500000000001,44.475,0.9585539600098858 -14,2019-04-18,-109.22500000000001,44.475,0.9586076250587394 -14,2019-04-19,-109.22500000000001,44.475,0.9585933664351848 -14,2019-04-20,-109.22500000000001,44.475,0.9585252763775142 -14,2019-04-21,-109.22500000000001,44.475,0.9585292775026194 -14,2019-04-22,-109.22500000000001,44.475,0.9588297261876391 -14,2019-04-23,-109.22500000000001,44.475,0.9593095148796565 -14,2019-04-24,-109.22500000000001,44.475,0.9597193828478985 -14,2019-04-25,-109.22500000000001,44.475,0.9600970778364849 -14,2019-04-26,-109.22500000000001,44.475,0.960584412452134 -14,2019-04-27,-109.22500000000001,44.475,0.9611512774625073 -14,2019-04-28,-109.22500000000001,44.475,0.96163881377352 -14,2019-04-29,-109.22500000000001,44.475,0.9620575135047342 -14,2019-04-30,-109.22500000000001,44.475,0.9623224512910176 -14,2019-05-01,-109.22500000000001,44.475,0.9624294710239345 -14,2019-05-02,-109.22500000000001,44.475,0.9623874015820131 -14,2019-05-03,-109.22500000000001,44.475,0.9622441696384906 -14,2019-05-04,-109.22500000000001,44.475,0.9620315259861458 -14,2019-05-05,-109.22500000000001,44.475,0.9618637624418686 -14,2019-05-06,-109.22500000000001,44.475,0.961689502015963 -14,2019-05-07,-109.22500000000001,44.475,0.9615483742837724 -14,2019-05-08,-109.22500000000001,44.475,0.961577044517372 -14,2019-05-09,-109.22500000000001,44.475,0.9616054792050417 -14,2019-05-10,-109.22500000000001,44.475,0.9615990336850984 -14,2019-05-11,-109.22500000000001,44.475,0.9614898909741757 -14,2019-05-12,-109.22500000000001,44.475,0.9612789143615612 -14,2019-05-13,-109.22500000000001,44.475,0.9610279866063127 -14,2019-05-14,-109.22500000000001,44.475,0.9608425217869395 -14,2019-05-15,-109.22500000000001,44.475,0.9608296525474004 -14,2019-05-16,-109.22500000000001,44.475,0.9610756506940152 -14,2019-05-17,-109.22500000000001,44.475,0.9617204638062492 -14,2019-05-18,-109.22500000000001,44.475,0.962910966240782 -14,2019-05-19,-109.22500000000001,44.475,0.9642712243147974 -14,2019-05-20,-109.22500000000001,44.475,0.9653840598532519 -14,2019-05-21,-109.22500000000001,44.475,0.966183875705415 -14,2019-05-22,-109.22500000000001,44.475,0.9667004181344535 -14,2019-05-23,-109.22500000000001,44.475,0.9671028497689881 -14,2019-05-24,-109.22500000000001,44.475,0.9673033332255049 -14,2019-05-25,-109.22500000000001,44.475,0.9673039036243318 -14,2019-05-26,-109.22500000000001,44.475,0.9671966417162294 -14,2019-05-27,-109.22500000000001,44.475,0.9670944376152864 -14,2019-05-28,-109.22500000000001,44.475,0.9673755006705765 -14,2019-05-29,-109.22500000000001,44.475,0.9680171674228267 -14,2019-05-30,-109.22500000000001,44.475,0.9687011086097475 -14,2019-05-31,-109.22500000000001,44.475,0.969308606169119 -14,2019-06-01,-109.22500000000001,44.475,0.9698277221028141 -14,2019-06-02,-109.22500000000001,44.475,0.970498845093535 -14,2019-06-03,-109.22500000000001,44.475,0.9714377154151642 -14,2019-06-04,-109.22500000000001,44.475,0.9726035275676809 -14,2019-06-05,-109.22500000000001,44.475,0.9741751843738795 -14,2019-06-06,-109.22500000000001,44.475,0.9762276029748355 -14,2019-06-07,-109.22500000000001,44.475,0.9788351532168975 -14,2019-06-08,-109.22500000000001,44.475,0.982232917966899 -14,2019-06-09,-109.22500000000001,44.475,0.986011235886495 -14,2019-06-10,-109.22500000000001,44.475,0.9876115547313764 -14,2019-06-11,-109.22500000000001,44.475,0.9879611913075118 -14,2019-06-12,-109.22500000000001,44.475,0.9879341769332671 -14,2019-06-13,-109.22500000000001,44.475,0.9878987318687106 -14,2019-06-14,-109.22500000000001,44.475,0.9879650271869014 -14,2019-06-15,-109.22500000000001,44.475,0.9882524731058544 -14,2019-06-16,-109.22500000000001,44.475,0.9886720707997373 -14,2019-06-17,-109.22500000000001,44.475,0.9891054673508263 -14,2019-06-18,-109.22500000000001,44.475,0.9894667922552267 -14,2019-06-19,-109.22500000000001,44.475,0.9897728724186947 -14,2019-06-20,-109.22500000000001,44.475,0.9899855274321828 -14,2019-06-21,-109.22500000000001,44.475,0.9901638560080477 -14,2019-06-22,-109.22500000000001,44.475,0.9902093198914377 -14,2019-06-23,-109.22500000000001,44.475,0.9900622943130118 -14,2019-06-24,-109.22500000000001,44.475,0.9898156486784535 -14,2019-06-25,-109.22500000000001,44.475,0.9895890445683205 -14,2019-06-26,-109.22500000000001,44.475,0.9894614320628144 -14,2019-06-27,-109.22500000000001,44.475,0.989428776651833 -14,2019-06-28,-109.22500000000001,44.475,0.9894709030679858 -14,2019-06-29,-109.22500000000001,44.475,0.9895921852940197 -14,2019-06-30,-109.22500000000001,44.475,0.989729220312056 -14,2019-07-01,-109.22500000000001,44.475,0.9898754460239879 -14,2019-07-02,-109.22500000000001,44.475,0.9899675618414663 -14,2019-07-03,-109.22500000000001,44.475,0.9899372093920517 -14,2019-07-04,-109.22500000000001,44.475,0.9898915297412823 -14,2019-07-05,-109.22500000000001,44.475,0.989794292895092 -14,2019-07-06,-109.22500000000001,44.475,0.9896567911399206 -14,2019-07-07,-109.22500000000001,44.475,0.9894569370261446 -14,2019-07-08,-109.22500000000001,44.475,0.9892086354472037 -14,2019-07-09,-109.22500000000001,44.475,0.9890011422619216 -14,2019-07-10,-109.22500000000001,44.475,0.988800200892552 -14,2019-07-11,-109.22500000000001,44.475,0.9886132971805234 -14,2019-07-12,-109.22500000000001,44.475,0.9883993015776281 -14,2019-07-13,-109.22500000000001,44.475,0.9881765179942286 -14,2019-07-14,-109.22500000000001,44.475,0.9879640073456534 -14,2019-07-15,-109.22500000000001,44.475,0.9877544256292121 -14,2019-07-16,-109.22500000000001,44.475,0.9875617855383138 -14,2019-07-17,-109.22500000000001,44.475,0.9874143742570611 -14,2019-07-18,-109.22500000000001,44.475,0.9872512668060541 -14,2019-07-19,-109.22500000000001,44.475,0.9870770800326437 -14,2019-07-20,-109.22500000000001,44.475,0.9869051500084595 -14,2019-07-21,-109.22500000000001,44.475,0.9867346980915649 -14,2019-07-22,-109.22500000000001,44.475,0.9865705945762642 -14,2019-07-23,-109.22500000000001,44.475,0.9864195220560315 -14,2019-07-24,-109.22500000000001,44.475,0.9862749170525142 -14,2019-07-25,-109.22500000000001,44.475,0.9861498512799599 -14,2019-07-26,-109.22500000000001,44.475,0.9860020769170592 -14,2019-07-27,-109.22500000000001,44.475,0.9858817447261979 -14,2019-07-28,-109.22500000000001,44.475,0.9857762030869675 -14,2019-07-29,-109.22500000000001,44.475,0.9856611298767293 -14,2019-07-30,-109.22500000000001,44.475,0.9855590268648953 -14,2019-07-31,-109.22500000000001,44.475,0.985456219627291 -14,2019-08-01,-109.22500000000001,44.475,0.9853698833818705 -14,2019-08-02,-109.22500000000001,44.475,0.9852716532996245 -14,2019-08-03,-109.22500000000001,44.475,0.9851823483019074 -14,2019-08-04,-109.22500000000001,44.475,0.9850960476366291 -14,2019-08-05,-109.22500000000001,44.475,0.985017771812998 -14,2019-08-06,-109.22500000000001,44.475,0.9849400880170837 -14,2019-08-07,-109.22500000000001,44.475,0.9848693524909523 -14,2019-08-08,-109.22500000000001,44.475,0.984801983915467 -14,2019-08-09,-109.22500000000001,44.475,0.9847355443125219 -14,2019-08-10,-109.22500000000001,44.475,0.9846733360494438 -14,2019-08-11,-109.22500000000001,44.475,0.9846166686208174 -14,2019-08-12,-109.22500000000001,44.475,0.984544025425672 -14,2019-08-13,-109.22500000000001,44.475,0.9844049125000436 -14,2019-08-14,-109.22500000000001,44.475,0.9841993306970908 -14,2019-08-15,-109.22500000000001,44.475,0.9839311055663913 -14,2019-08-16,-109.22500000000001,44.475,0.9835947936950866 -14,2019-08-17,-109.22500000000001,44.475,0.9832036188103939 -14,2019-08-18,-109.22500000000001,44.475,0.9828181226997308 -14,2019-08-19,-109.22500000000001,44.475,0.9823779975551722 -14,2019-08-20,-109.22500000000001,44.475,0.9818514367844653 -14,2019-08-21,-109.22500000000001,44.475,0.9812712791336935 -14,2019-08-22,-109.22500000000001,44.475,0.9806727508064619 -14,2019-08-23,-109.22500000000001,44.475,0.9800608358099397 -14,2019-08-24,-109.22500000000001,44.475,0.9794677984390651 -14,2019-08-25,-109.22500000000001,44.475,0.9788220073655729 -14,2019-08-26,-109.22500000000001,44.475,0.9780967411276442 -14,2019-08-27,-109.22500000000001,44.475,0.9773378204802711 -14,2019-08-28,-109.22500000000001,44.475,0.9765498399693006 -14,2019-08-29,-109.22500000000001,44.475,0.9757197398305427 -14,2019-08-30,-109.22500000000001,44.475,0.9748464229478352 -14,2019-08-31,-109.22500000000001,44.475,0.9739601132384782 -14,2019-09-01,-109.22500000000001,44.475,0.9730480785087511 -14,2019-09-02,-109.22500000000001,44.475,0.9721280451250115 -14,2019-09-03,-109.22500000000001,44.475,0.9712148468687 -14,2019-09-04,-109.22500000000001,44.475,0.970304096960517 -14,2019-09-05,-109.22500000000001,44.475,0.9693961310239178 -14,2019-09-06,-109.22500000000001,44.475,0.9692374935564989 -14,2019-09-07,-109.22500000000001,44.475,0.9692350515569388 -14,2019-09-08,-109.22500000000001,44.475,0.9692342232084252 -14,2019-09-09,-109.22500000000001,44.475,0.9692333860270083 -14,2019-09-10,-109.22500000000001,44.475,0.9692325576784948 -14,2019-09-11,-109.22500000000001,44.475,0.9690790059135773 -14,2019-09-12,-109.22500000000001,44.475,0.9684564864678596 -14,2019-09-13,-109.22500000000001,44.475,0.9678020299632061 -14,2019-09-14,-109.22500000000001,44.475,0.9671001505869867 -14,2019-09-15,-109.22500000000001,44.475,0.9664404053431572 -14,2019-09-16,-109.22500000000001,44.475,0.9658494316158076 -14,2019-09-17,-109.22500000000001,44.475,0.965323767658879 -14,2019-09-18,-109.22500000000001,44.475,0.9649124290011791 -14,2019-09-19,-109.22500000000001,44.475,0.9645369140712233 -14,2019-09-20,-109.22500000000001,44.475,0.9641918545556156 -14,2019-09-21,-109.22500000000001,44.475,0.9639431023915226 -14,2019-09-22,-109.22500000000001,44.475,0.9638144899538157 -14,2019-09-23,-109.22500000000001,44.475,0.9636707237528129 -14,2019-09-24,-109.22500000000001,44.475,0.963484461674539 -14,2019-09-25,-109.22500000000001,44.475,0.9632936767708669 -14,2019-09-26,-109.22500000000001,44.475,0.9631172206911212 -14,2019-09-27,-109.22500000000001,44.475,0.9629623613415147 -14,2019-09-28,-109.22500000000001,44.475,0.9629709707565777 -14,2019-09-29,-109.22500000000001,44.475,0.9631020066003788 -14,2019-09-30,-109.22500000000001,44.475,0.9632450216598522 -14,2019-10-01,-109.22500000000001,44.475,0.9632657455569882 -14,2019-10-02,-109.22500000000001,44.475,0.9632116893136837 -14,2019-10-03,-109.22500000000001,44.475,0.9630965135285882 -14,2019-10-04,-109.22500000000001,44.475,0.9629573025807244 -14,2019-10-05,-109.22500000000001,44.475,0.9628792663592161 -14,2019-10-06,-109.22500000000001,44.475,0.9627953443819752 -14,2019-10-07,-109.22500000000001,44.475,0.9626823835844103 -14,2019-10-08,-109.22500000000001,44.475,0.962556867828043 -14,2019-10-09,-109.22500000000001,44.475,0.9624296737693706 -14,2019-10-10,-109.22500000000001,44.475,0.9623616470793269 -14,2019-10-11,-109.22500000000001,44.475,0.9623065406216758 -14,2019-10-12,-109.22500000000001,44.475,0.962231912632405 -14,2019-10-13,-109.22500000000001,44.475,0.9621469784462147 -14,2019-10-14,-109.22500000000001,44.475,0.9620947494197689 -14,2019-10-15,-109.22500000000001,44.475,0.9620310234085376 -14,2019-10-16,-109.22500000000001,44.475,0.9619607041042074 -14,2019-10-17,-109.22500000000001,44.475,0.9618861273701764 -14,2019-10-18,-109.22500000000001,44.475,0.9618240306356347 -14,2019-10-19,-109.22500000000001,44.475,0.9617796414237871 -14,2019-10-20,-109.22500000000001,44.475,0.9617438478888813 -14,2019-10-21,-109.22500000000001,44.475,0.9617060900358058 -14,2019-10-22,-109.22500000000001,44.475,0.9616629457442613 -14,2019-10-23,-109.22500000000001,44.475,0.9616299042777838 -14,2019-10-24,-109.22500000000001,44.475,0.9616081016541034 -14,2019-10-25,-109.22500000000001,44.475,0.9615719731613087 -14,2019-10-26,-109.22500000000001,44.475,0.9615251395432078 -14,2019-10-27,-109.22500000000001,44.475,0.9615554843350359 -14,2019-10-28,-109.22500000000001,44.475,0.9615577730166183 -14,2019-10-29,-109.22500000000001,44.475,0.9615276150245987 -14,2019-10-30,-109.22500000000001,44.475,0.9614819241658514 -14,2019-10-31,-109.22500000000001,44.475,0.9614315527517279 -14,2019-11-01,-109.22500000000001,44.475,0.9613749723547333 -14,2019-11-02,-109.22500000000001,44.475,0.9613126576392876 -14,2019-11-03,-109.22500000000001,44.475,0.9612495059176281 -14,2019-11-04,-109.22500000000001,44.475,0.9612235472804536 -14,2019-11-05,-109.22500000000001,44.475,0.961188089364694 -14,2019-11-06,-109.22500000000001,44.475,0.9611401025157972 -14,2019-11-07,-109.22500000000001,44.475,0.9610911399745956 -14,2019-11-08,-109.22500000000001,44.475,0.9610421374983352 -14,2019-11-09,-109.22500000000001,44.475,0.9609836284705777 -14,2019-11-10,-109.22500000000001,44.475,0.9609578771401163 -14,2019-11-11,-109.22500000000001,44.475,0.9609417557527954 -14,2019-11-12,-109.22500000000001,44.475,0.9609122561458683 -14,2019-11-13,-109.22500000000001,44.475,0.9608677640601847 -14,2019-11-14,-109.22500000000001,44.475,0.9608110610305495 -14,2019-11-15,-109.22500000000001,44.475,0.9607566955767413 -14,2019-11-16,-109.22500000000001,44.475,0.9607014777111169 -14,2019-11-17,-109.22500000000001,44.475,0.960673535472466 -14,2019-11-18,-109.22500000000001,44.475,0.9606523017541939 -14,2019-11-19,-109.22500000000001,44.475,0.960609024662481 -14,2019-11-20,-109.22500000000001,44.475,0.9605614374187597 -14,2019-11-21,-109.22500000000001,44.475,0.9605351397426 -14,2019-11-22,-109.22500000000001,44.475,0.9605041362884882 -14,2019-11-23,-109.22500000000001,44.475,0.9604662778778795 -14,2019-11-24,-109.22500000000001,44.475,0.9604235420593938 -14,2019-11-25,-109.22500000000001,44.475,0.960381969397608 -14,2019-11-26,-109.22500000000001,44.475,0.9603425951754176 -14,2019-11-27,-109.22500000000001,44.475,0.9603008584457577 -14,2019-11-28,-109.22500000000001,44.475,0.9602581730434837 -14,2019-11-29,-109.22500000000001,44.475,0.9602128650825413 -14,2019-11-30,-109.22500000000001,44.475,0.9601633428166628 -14,2019-12-01,-109.22500000000001,44.475,0.960108836100334 -14,2019-12-02,-109.22500000000001,44.475,0.9600556189001912 -14,2019-12-03,-109.22500000000001,44.475,0.9600018718864403 -14,2019-12-04,-109.22500000000001,44.475,0.9600486452633371 -14,2019-12-05,-109.22500000000001,44.475,0.9600753647757128 -14,2019-12-06,-109.22500000000001,44.475,0.9600405861904546 -14,2019-12-07,-109.22500000000001,44.475,0.9599790250194289 -14,2019-12-08,-109.22500000000001,44.475,0.9599124494656118 -14,2019-12-09,-109.22500000000001,44.475,0.9599018417041814 -14,2019-12-10,-109.22500000000001,44.475,0.9598863821645535 -14,2019-12-11,-109.22500000000001,44.475,0.9598402331694349 -14,2019-12-12,-109.22500000000001,44.475,0.9597818785140476 -14,2019-12-13,-109.22500000000001,44.475,0.9597133851807643 -14,2019-12-14,-109.22500000000001,44.475,0.959642659839733 -14,2019-12-15,-109.22500000000001,44.475,0.959575473926433 -14,2019-12-16,-109.22500000000001,44.475,0.9595113752991336 -14,2019-12-17,-109.22500000000001,44.475,0.9594488351682346 -14,2019-12-18,-109.22500000000001,44.475,0.9593896536946078 -14,2019-12-19,-109.22500000000001,44.475,0.9593309026369656 -14,2019-12-20,-109.22500000000001,44.475,0.9592740260755682 -14,2019-12-21,-109.22500000000001,44.475,0.9592243768337804 -14,2019-12-22,-109.22500000000001,44.475,0.9591734883464318 -14,2019-12-23,-109.22500000000001,44.475,0.9591176434451206 -14,2019-12-24,-109.22500000000001,44.475,0.9590592921649703 -14,2019-12-25,-109.22500000000001,44.475,0.9589997420446923 -14,2019-12-26,-109.22500000000001,44.475,0.9589433805115064 -14,2019-12-27,-109.22500000000001,44.475,0.9588908566793645 -14,2019-12-28,-109.22500000000001,44.475,0.9588413566311248 -14,2019-12-29,-109.22500000000001,44.475,0.9587904580452776 -14,2019-12-30,-109.22500000000001,44.475,0.9587410324954366 -14,2019-12-31,-109.22500000000001,44.475,0.9586918892914859 -14,2020-01-01,-109.22500000000001,44.475,0.9586411206739747 -31,2018-01-02,-109.97500000000001,48.625,0.9671472618336213 -31,2018-01-03,-109.97500000000001,48.625,0.9671383112197397 -31,2018-01-04,-109.97500000000001,48.625,0.9671261976642926 -31,2018-01-05,-109.97500000000001,48.625,0.9671111880517783 -31,2018-01-06,-109.97500000000001,48.625,0.9670939339266167 -31,2018-01-07,-109.97500000000001,48.625,0.9670736455388381 -31,2018-01-08,-109.97500000000001,48.625,0.967050224352118 -31,2018-01-09,-109.97500000000001,48.625,0.9670246103856363 -31,2018-01-10,-109.97500000000001,48.625,0.9669969812175192 -31,2018-01-11,-109.97500000000001,48.625,0.9669676567541781 -31,2018-01-12,-109.97500000000001,48.625,0.9669371346039992 -31,2018-01-13,-109.97500000000001,48.625,0.9669065240809447 -31,2018-01-14,-109.97500000000001,48.625,0.9668757138962643 -31,2018-01-15,-109.97500000000001,48.625,0.9668448328467069 -31,2018-01-16,-109.97500000000001,48.625,0.9668143974255361 -31,2018-01-17,-109.97500000000001,48.625,0.9667843653505355 -31,2018-01-18,-109.97500000000001,48.625,0.9667539826522279 -31,2018-01-19,-109.97500000000001,48.625,0.9667252485911411 -31,2018-01-20,-109.97500000000001,48.625,0.9667004942902829 -31,2018-01-21,-109.97500000000001,48.625,0.9666780854952354 -31,2018-01-22,-109.97500000000001,48.625,0.9666576501998856 -31,2018-01-23,-109.97500000000001,48.625,0.9666376872993724 -31,2018-01-24,-109.97500000000001,48.625,0.9666172286357627 -31,2018-01-25,-109.97500000000001,48.625,0.9665959217818115 -31,2018-01-26,-109.97500000000001,48.625,0.966573314129471 -31,2018-01-27,-109.97500000000001,48.625,0.9665513112855482 -31,2018-01-28,-109.97500000000001,48.625,0.9665304975838278 -31,2018-01-29,-109.97500000000001,48.625,0.966510050603604 -31,2018-01-30,-109.97500000000001,48.625,0.9664880524246371 -31,2018-01-31,-109.97500000000001,48.625,0.9664730815217775 -31,2018-02-01,-109.97500000000001,48.625,0.9664714941016481 -31,2018-02-02,-109.97500000000001,48.625,0.9664712439682305 -31,2018-02-03,-109.97500000000001,48.625,0.9664709938348128 -31,2018-02-04,-109.97500000000001,48.625,0.9664707437013952 -31,2018-02-05,-109.97500000000001,48.625,0.9664704935679775 -31,2018-02-06,-109.97500000000001,48.625,0.9664702434345599 -31,2018-02-07,-109.97500000000001,48.625,0.9664699933011422 -31,2018-02-08,-109.97500000000001,48.625,0.9664694724052886 -31,2018-02-09,-109.97500000000001,48.625,0.966464714510124 -31,2018-02-10,-109.97500000000001,48.625,0.9664541577007938 -31,2018-02-11,-109.97500000000001,48.625,0.9664381217119586 -31,2018-02-12,-109.97500000000001,48.625,0.966416323577317 -31,2018-02-13,-109.97500000000001,48.625,0.9663893462845426 -31,2018-02-14,-109.97500000000001,48.625,0.9663575668949904 -31,2018-02-15,-109.97500000000001,48.625,0.9663190158010752 -31,2018-02-16,-109.97500000000001,48.625,0.9662744833220313 -31,2018-02-17,-109.97500000000001,48.625,0.9662259955311374 -31,2018-02-18,-109.97500000000001,48.625,0.9661745910456274 -31,2018-02-19,-109.97500000000001,48.625,0.9661204576968991 -31,2018-02-20,-109.97500000000001,48.625,0.9660639479112633 -31,2018-02-21,-109.97500000000001,48.625,0.966005903924732 -31,2018-02-22,-109.97500000000001,48.625,0.9659459629361973 -31,2018-02-23,-109.97500000000001,48.625,0.9658838019400724 -31,2018-02-24,-109.97500000000001,48.625,0.9658189018125344 -31,2018-02-25,-109.97500000000001,48.625,0.9657504642577547 -31,2018-02-26,-109.97500000000001,48.625,0.9656781523344614 -31,2018-02-27,-109.97500000000001,48.625,0.9656022237724825 -31,2018-02-28,-109.97500000000001,48.625,0.9655231350265674 -31,2018-03-01,-109.97500000000001,48.625,0.965441393500151 -31,2018-03-02,-109.97500000000001,48.625,0.9653577011013714 -31,2018-03-03,-109.97500000000001,48.625,0.9652727547494415 -31,2018-03-04,-109.97500000000001,48.625,0.9651865920089334 -31,2018-03-05,-109.97500000000001,48.625,0.9650992696559918 -31,2018-03-06,-109.97500000000001,48.625,0.965011392651784 -31,2018-03-07,-109.97500000000001,48.625,0.9649233622182254 -31,2018-03-08,-109.97500000000001,48.625,0.9648352950818521 -31,2018-03-09,-109.97500000000001,48.625,0.9647472136876544 -31,2018-03-10,-109.97500000000001,48.625,0.9646591282528814 -31,2018-03-11,-109.97500000000001,48.625,0.9645710419490476 -31,2018-03-12,-109.97500000000001,48.625,0.964482955344974 -31,2018-03-13,-109.97500000000001,48.625,0.964394868574875 -31,2018-03-14,-109.97500000000001,48.625,0.9643067816277824 -31,2018-03-15,-109.97500000000001,48.625,0.9642186944722306 -31,2018-03-16,-109.97500000000001,48.625,0.9641306071544413 -31,2018-03-17,-109.97500000000001,48.625,0.9640425197425166 -31,2018-03-18,-109.97500000000001,48.625,0.9639544322360094 -31,2018-03-19,-109.97500000000001,48.625,0.9638663445954949 -31,2018-03-20,-109.97500000000001,48.625,0.9637782568075913 -31,2018-03-21,-109.97500000000001,48.625,0.9636901688400781 -31,2018-03-22,-109.97500000000001,48.625,0.9636020806667922 -31,2018-03-23,-109.97500000000001,48.625,0.9635139923220066 -31,2018-03-24,-109.97500000000001,48.625,0.9634287929979615 -31,2018-03-25,-109.97500000000001,48.625,0.9633511472726239 -31,2018-03-26,-109.97500000000001,48.625,0.9632743006705964 -31,2018-03-27,-109.97500000000001,48.625,0.9631953715611785 -31,2018-03-28,-109.97500000000001,48.625,0.9631144166951389 -31,2018-03-29,-109.97500000000001,48.625,0.963032674912859 -31,2018-03-30,-109.97500000000001,48.625,0.9629504632905864 -31,2018-03-31,-109.97500000000001,48.625,0.9628672866723476 -31,2018-04-01,-109.97500000000001,48.625,0.9627833487263199 -31,2018-04-02,-109.97500000000001,48.625,0.9626983570772819 -31,2018-04-03,-109.97500000000001,48.625,0.962612629767038 -31,2018-04-04,-109.97500000000001,48.625,0.9625257893551338 -31,2018-04-05,-109.97500000000001,48.625,0.9624381152362472 -31,2018-04-06,-109.97500000000001,48.625,0.9623501633847428 -31,2018-04-07,-109.97500000000001,48.625,0.9622621012499144 -31,2018-04-08,-109.97500000000001,48.625,0.9621740006634235 -31,2018-04-09,-109.97500000000001,48.625,0.9620858850631873 -31,2018-04-10,-109.97500000000001,48.625,0.9619977618616563 -31,2018-04-11,-109.97500000000001,48.625,0.9619096355475998 -31,2018-04-12,-109.97500000000001,48.625,0.9618233826195242 -31,2018-04-13,-109.97500000000001,48.625,0.9617432609450628 -31,2018-04-14,-109.97500000000001,48.625,0.961662912164547 -31,2018-04-15,-109.97500000000001,48.625,0.9615822500554169 -31,2018-04-16,-109.97500000000001,48.625,0.9615124088716434 -31,2018-04-17,-109.97500000000001,48.625,0.9614775525952212 -31,2018-04-18,-109.97500000000001,48.625,0.9614769834716655 -31,2018-04-19,-109.97500000000001,48.625,0.9614766711217085 -31,2018-04-20,-109.97500000000001,48.625,0.9614763587717515 -31,2018-04-21,-109.97500000000001,48.625,0.9614760464217945 -31,2018-04-22,-109.97500000000001,48.625,0.9614757340718375 -31,2018-04-23,-109.97500000000001,48.625,0.9614620188481363 -31,2018-04-24,-109.97500000000001,48.625,0.9626192131936874 -31,2018-04-25,-109.97500000000001,48.625,0.9651859699812263 -31,2018-04-26,-109.97500000000001,48.625,0.9688646154392304 -31,2018-04-27,-109.97500000000001,48.625,0.973335766418965 -31,2018-04-28,-109.97500000000001,48.625,0.9782560134631916 -31,2018-04-29,-109.97500000000001,48.625,0.9830668011607637 -31,2018-04-30,-109.97500000000001,48.625,0.9852021615700904 -31,2018-05-01,-109.97500000000001,48.625,0.9858759000673211 -31,2018-05-02,-109.97500000000001,48.625,0.9859761370203723 -31,2018-05-03,-109.97500000000001,48.625,0.9858345524092279 -31,2018-05-04,-109.97500000000001,48.625,0.9855609153330859 -31,2018-05-05,-109.97500000000001,48.625,0.9852065353046053 -31,2018-05-06,-109.97500000000001,48.625,0.9848324310534121 -31,2018-05-07,-109.97500000000001,48.625,0.9844860674399294 -31,2018-05-08,-109.97500000000001,48.625,0.9842026632679935 -31,2018-05-09,-109.97500000000001,48.625,0.9839793316260814 -31,2018-05-10,-109.97500000000001,48.625,0.9838189548223039 -31,2018-05-11,-109.97500000000001,48.625,0.983712529317593 -31,2018-05-12,-109.97500000000001,48.625,0.9836509791014307 -31,2018-05-13,-109.97500000000001,48.625,0.9836136664420104 -31,2018-05-14,-109.97500000000001,48.625,0.9835811078151617 -31,2018-05-15,-109.97500000000001,48.625,0.9835361905261576 -31,2018-05-16,-109.97500000000001,48.625,0.9834426274776397 -31,2018-05-17,-109.97500000000001,48.625,0.9833011663124247 -31,2018-05-18,-109.97500000000001,48.625,0.983152903229095 -31,2018-05-19,-109.97500000000001,48.625,0.9830385678236234 -31,2018-05-20,-109.97500000000001,48.625,0.9829487481391187 -31,2018-05-21,-109.97500000000001,48.625,0.9828750020214087 -31,2018-05-22,-109.97500000000001,48.625,0.9828428472310264 -31,2018-05-23,-109.97500000000001,48.625,0.9828628835012728 -31,2018-05-24,-109.97500000000001,48.625,0.9828978751235918 -31,2018-05-25,-109.97500000000001,48.625,0.9828661173018373 -31,2018-05-26,-109.97500000000001,48.625,0.9827615444423033 -31,2018-05-27,-109.97500000000001,48.625,0.9826335163547204 -31,2018-05-28,-109.97500000000001,48.625,0.9825336405098295 -31,2018-05-29,-109.97500000000001,48.625,0.982433748601139 -31,2018-05-30,-109.97500000000001,48.625,0.9823354741688305 -31,2018-05-31,-109.97500000000001,48.625,0.9822552146747223 -31,2018-06-01,-109.97500000000001,48.625,0.9822012927234055 -31,2018-06-02,-109.97500000000001,48.625,0.9821945094708391 -31,2018-06-03,-109.97500000000001,48.625,0.9822416081610161 -31,2018-06-04,-109.97500000000001,48.625,0.9824649041760576 -31,2018-06-05,-109.97500000000001,48.625,0.9828048724593051 -31,2018-06-06,-109.97500000000001,48.625,0.9830788221990323 -31,2018-06-07,-109.97500000000001,48.625,0.9831424746127639 -31,2018-06-08,-109.97500000000001,48.625,0.9830042466407267 -31,2018-06-09,-109.97500000000001,48.625,0.982766596478612 -31,2018-06-10,-109.97500000000001,48.625,0.9825164100659907 -31,2018-06-11,-109.97500000000001,48.625,0.9823075839635461 -31,2018-06-12,-109.97500000000001,48.625,0.9821531255750523 -31,2018-06-13,-109.97500000000001,48.625,0.9820438043229055 -31,2018-06-14,-109.97500000000001,48.625,0.9819719972424811 -31,2018-06-15,-109.97500000000001,48.625,0.9819497912149646 -31,2018-06-16,-109.97500000000001,48.625,0.9819523918087973 -31,2018-06-17,-109.97500000000001,48.625,0.9819662901836642 -31,2018-06-18,-109.97500000000001,48.625,0.9819539685150065 -31,2018-06-19,-109.97500000000001,48.625,0.981923690609916 -31,2018-06-20,-109.97500000000001,48.625,0.9818980452528343 -31,2018-06-21,-109.97500000000001,48.625,0.9819443897358592 -31,2018-06-22,-109.97500000000001,48.625,0.9820901708514748 -31,2018-06-23,-109.97500000000001,48.625,0.9822751007484479 -31,2018-06-24,-109.97500000000001,48.625,0.9824131456431396 -31,2018-06-25,-109.97500000000001,48.625,0.9824696983859138 -31,2018-06-26,-109.97500000000001,48.625,0.9824322185475137 -31,2018-06-27,-109.97500000000001,48.625,0.9823354153855117 -31,2018-06-28,-109.97500000000001,48.625,0.9822170330152701 -31,2018-06-29,-109.97500000000001,48.625,0.9821202350397282 -31,2018-06-30,-109.97500000000001,48.625,0.982062263951723 -31,2018-07-01,-109.97500000000001,48.625,0.9820164913742252 -31,2018-07-02,-109.97500000000001,48.625,0.981961034568311 -31,2018-07-03,-109.97500000000001,48.625,0.9818924553783636 -31,2018-07-04,-109.97500000000001,48.625,0.981774567596694 -31,2018-07-05,-109.97500000000001,48.625,0.9816183540739352 -31,2018-07-06,-109.97500000000001,48.625,0.9814264545751442 -31,2018-07-07,-109.97500000000001,48.625,0.981172683532058 -31,2018-07-08,-109.97500000000001,48.625,0.9808628665070508 -31,2018-07-09,-109.97500000000001,48.625,0.9805137480598215 -31,2018-07-10,-109.97500000000001,48.625,0.980130248806346 -31,2018-07-11,-109.97500000000001,48.625,0.9797478429243189 -31,2018-07-12,-109.97500000000001,48.625,0.9793766859720285 -31,2018-07-13,-109.97500000000001,48.625,0.979011824742404 -31,2018-07-14,-109.97500000000001,48.625,0.9786589929037837 -31,2018-07-15,-109.97500000000001,48.625,0.9783206586570893 -31,2018-07-16,-109.97500000000001,48.625,0.9779860206379165 -31,2018-07-17,-109.97500000000001,48.625,0.9776520119008749 -31,2018-07-18,-109.97500000000001,48.625,0.9773254332514034 -31,2018-07-19,-109.97500000000001,48.625,0.977008628498834 -31,2018-07-20,-109.97500000000001,48.625,0.9767014347720168 -31,2018-07-21,-109.97500000000001,48.625,0.9764008364184626 -31,2018-07-22,-109.97500000000001,48.625,0.9761113634590673 -31,2018-07-23,-109.97500000000001,48.625,0.9758281020046399 -31,2018-07-24,-109.97500000000001,48.625,0.9755508251952746 -31,2018-07-25,-109.97500000000001,48.625,0.9752763856549473 -31,2018-07-26,-109.97500000000001,48.625,0.9750047445184297 -31,2018-07-27,-109.97500000000001,48.625,0.9747355124947669 -31,2018-07-28,-109.97500000000001,48.625,0.9744675098738209 -31,2018-07-29,-109.97500000000001,48.625,0.9742038864877292 -31,2018-07-30,-109.97500000000001,48.625,0.973945487500627 -31,2018-07-31,-109.97500000000001,48.625,0.97369236076981 -31,2018-08-01,-109.97500000000001,48.625,0.9734480204069412 -31,2018-08-02,-109.97500000000001,48.625,0.9732071262141987 -31,2018-08-03,-109.97500000000001,48.625,0.9729703219874318 -31,2018-08-04,-109.97500000000001,48.625,0.972741036626329 -31,2018-08-05,-109.97500000000001,48.625,0.9725155960166353 -31,2018-08-06,-109.97500000000001,48.625,0.972295723514117 -31,2018-08-07,-109.97500000000001,48.625,0.9720771903317602 -31,2018-08-08,-109.97500000000001,48.625,0.9718625492670566 -31,2018-08-09,-109.97500000000001,48.625,0.971656007334045 -31,2018-08-10,-109.97500000000001,48.625,0.9714572305872734 -31,2018-08-11,-109.97500000000001,48.625,0.97126157800018 -31,2018-08-12,-109.97500000000001,48.625,0.9710736801090483 -31,2018-08-13,-109.97500000000001,48.625,0.9708936082038482 -31,2018-08-14,-109.97500000000001,48.625,0.9707196383178576 -31,2018-08-15,-109.97500000000001,48.625,0.970546386033805 -31,2018-08-16,-109.97500000000001,48.625,0.9703759677069157 -31,2018-08-17,-109.97500000000001,48.625,0.9702091279828451 -31,2018-08-18,-109.97500000000001,48.625,0.9700458662083058 -31,2018-08-19,-109.97500000000001,48.625,0.9698860714130036 -31,2018-08-20,-109.97500000000001,48.625,0.9698587438034382 -31,2018-08-21,-109.97500000000001,48.625,0.9698583332409872 -31,2018-08-22,-109.97500000000001,48.625,0.9698573668174147 -31,2018-08-23,-109.97500000000001,48.625,0.9698549798290175 -31,2018-08-24,-109.97500000000001,48.625,0.9698532345297434 -31,2018-08-25,-109.97500000000001,48.625,0.9698520809634932 -31,2018-08-26,-109.97500000000001,48.625,0.9698516656791822 -31,2018-08-27,-109.97500000000001,48.625,0.9698504879899901 -31,2018-08-28,-109.97500000000001,48.625,0.9698500774275393 -31,2018-08-29,-109.97500000000001,48.625,0.9698496668650883 -31,2018-08-30,-109.97500000000001,48.625,0.9698488099944732 -31,2018-08-31,-109.97500000000001,48.625,0.9698482525476688 -31,2018-09-01,-109.97500000000001,48.625,0.9698478419852179 -31,2018-09-02,-109.97500000000001,48.625,0.9698474579773935 -31,2018-09-03,-109.97500000000001,48.625,0.9698462679687408 -31,2018-09-04,-109.97500000000001,48.625,0.9698456121179777 -31,2018-09-05,-109.97500000000001,48.625,0.9698452281101533 -31,2018-09-06,-109.97500000000001,48.625,0.9698448150735484 -31,2018-09-07,-109.97500000000001,48.625,0.9698443567124939 -31,2018-09-08,-109.97500000000001,48.625,0.9698434128345607 -31,2018-09-09,-109.97500000000001,48.625,0.9698417663314446 -31,2018-09-10,-109.97500000000001,48.625,0.9698413823236202 -31,2018-09-11,-109.97500000000001,48.625,0.9698405200482514 -31,2018-09-12,-109.97500000000001,48.625,0.9698401360404268 -31,2018-09-13,-109.97500000000001,48.625,0.9698397520326024 -31,2018-09-14,-109.97500000000001,48.625,0.969839368024778 -31,2018-09-15,-109.97500000000001,48.625,0.9698389840169535 -31,2018-09-16,-109.97500000000001,48.625,0.969838600009129 -31,2018-09-17,-109.97500000000001,48.625,0.9698382160013046 -31,2018-09-18,-109.97500000000001,48.625,0.9698378319934802 -31,2018-09-19,-109.97500000000001,48.625,0.9698374479856556 -31,2018-09-20,-109.97500000000001,48.625,0.9698370639778312 -31,2018-09-21,-109.97500000000001,48.625,0.9698366799700068 -31,2018-09-22,-109.97500000000001,48.625,0.9698362959621822 -31,2018-09-23,-109.97500000000001,48.625,0.9698359119543578 -31,2018-09-24,-109.97500000000001,48.625,0.9698355279465334 -31,2018-09-25,-109.97500000000001,48.625,0.969835143938709 -31,2018-09-26,-109.97500000000001,48.625,0.9698347599308844 -31,2018-09-27,-109.97500000000001,48.625,0.96983437592306 -31,2018-09-28,-109.97500000000001,48.625,0.9698339919152356 -31,2018-09-29,-109.97500000000001,48.625,0.969833607907411 -31,2018-09-30,-109.97500000000001,48.625,0.9698332238995866 -31,2018-10-01,-109.97500000000001,48.625,0.9698328398917622 -31,2018-10-02,-109.97500000000001,48.625,0.9698325275418052 -31,2018-10-03,-109.97500000000001,48.625,0.969832215191848 -31,2018-10-04,-109.97500000000001,48.625,0.969831902841891 -31,2018-10-05,-109.97500000000001,48.625,0.969831590491934 -31,2018-10-06,-109.97500000000001,48.625,0.969831278141977 -31,2018-10-07,-109.97500000000001,48.625,0.96983096579202 -31,2018-10-08,-109.97500000000001,48.625,0.969830653442063 -31,2018-10-09,-109.97500000000001,48.625,0.9698303410921059 -31,2018-10-10,-109.97500000000001,48.625,0.9698300287421489 -31,2018-10-11,-109.97500000000001,48.625,0.9698297163921918 -31,2018-10-12,-109.97500000000001,48.625,0.9698294040422348 -31,2018-10-13,-109.97500000000001,48.625,0.9698290916922778 -31,2018-10-14,-109.97500000000001,48.625,0.9698287793423208 -31,2018-10-15,-109.97500000000001,48.625,0.9698284669923637 -31,2018-10-16,-109.97500000000001,48.625,0.9698281546424067 -31,2018-10-17,-109.97500000000001,48.625,0.9698278422924497 -31,2018-10-18,-109.97500000000001,48.625,0.9698275299424927 -31,2018-10-19,-109.97500000000001,48.625,0.9698272175925357 -31,2018-10-20,-109.97500000000001,48.625,0.9698269052425786 -31,2018-10-21,-109.97500000000001,48.625,0.9698265928926215 -31,2018-10-22,-109.97500000000001,48.625,0.9698262805426645 -31,2018-10-23,-109.97500000000001,48.625,0.9698259681927075 -31,2018-10-24,-109.97500000000001,48.625,0.9698256558427505 -31,2018-10-25,-109.97500000000001,48.625,0.9698253434927935 -31,2018-10-26,-109.97500000000001,48.625,0.9698250311428364 -31,2018-10-27,-109.97500000000001,48.625,0.9698247187928793 -31,2018-10-28,-109.97500000000001,48.625,0.9698244064429223 -31,2018-10-29,-109.97500000000001,48.625,0.9698240940929653 -31,2018-10-30,-109.97500000000001,48.625,0.9698237817430083 -31,2018-10-31,-109.97500000000001,48.625,0.9698234693930513 -31,2018-11-01,-109.97500000000001,48.625,0.9698231570430942 -31,2018-11-02,-109.97500000000001,48.625,0.9698228820862379 -31,2018-11-03,-109.97500000000001,48.625,0.9698226071293815 -31,2018-11-04,-109.97500000000001,48.625,0.9698223321725251 -31,2018-11-05,-109.97500000000001,48.625,0.9698220572156687 -31,2018-11-06,-109.97500000000001,48.625,0.9698217822588124 -31,2018-11-07,-109.97500000000001,48.625,0.969821507301956 -31,2018-11-08,-109.97500000000001,48.625,0.9698212323450996 -31,2018-11-09,-109.97500000000001,48.625,0.9698209573882433 -31,2018-11-10,-109.97500000000001,48.625,0.9698206824313869 -31,2018-11-11,-109.97500000000001,48.625,0.9698204074745306 -31,2018-11-12,-109.97500000000001,48.625,0.9698201325176742 -31,2018-11-13,-109.97500000000001,48.625,0.9698198575608178 -31,2018-11-14,-109.97500000000001,48.625,0.9698195826039614 -31,2018-11-15,-109.97500000000001,48.625,0.9698193076471051 -31,2018-11-16,-109.97500000000001,48.625,0.9698190326902487 -31,2018-11-17,-109.97500000000001,48.625,0.9698187577333923 -31,2018-11-18,-109.97500000000001,48.625,0.9698184827765359 -31,2018-11-19,-109.97500000000001,48.625,0.9698182078196795 -31,2018-11-20,-109.97500000000001,48.625,0.9698179328628233 -31,2018-11-21,-109.97500000000001,48.625,0.9698176579059669 -31,2018-11-22,-109.97500000000001,48.625,0.9698173829491105 -31,2018-11-23,-109.97500000000001,48.625,0.9698171079922541 -31,2018-11-24,-109.97500000000001,48.625,0.9698168330353977 -31,2018-11-25,-109.97500000000001,48.625,0.9698165580785414 -31,2018-11-26,-109.97500000000001,48.625,0.969816283121685 -31,2018-11-27,-109.97500000000001,48.625,0.9698160081648286 -31,2018-11-28,-109.97500000000001,48.625,0.9698157332079722 -31,2018-11-29,-109.97500000000001,48.625,0.9698154582511159 -31,2018-11-30,-109.97500000000001,48.625,0.9698151832942595 -31,2018-12-01,-109.97500000000001,48.625,0.9698149083374031 -31,2018-12-02,-109.97500000000001,48.625,0.9698146447700361 -31,2018-12-03,-109.97500000000001,48.625,0.9698143812026692 -31,2018-12-04,-109.97500000000001,48.625,0.9698141176353021 -31,2018-12-05,-109.97500000000001,48.625,0.9698138540679352 -31,2018-12-06,-109.97500000000001,48.625,0.9698135905005681 -31,2018-12-07,-109.97500000000001,48.625,0.9698133269332011 -31,2018-12-08,-109.97500000000001,48.625,0.9698130633658342 -31,2018-12-09,-109.97500000000001,48.625,0.9698127997984671 -31,2018-12-10,-109.97500000000001,48.625,0.9698125362311002 -31,2018-12-11,-109.97500000000001,48.625,0.9698122726637332 -31,2018-12-12,-109.97500000000001,48.625,0.9698120090963661 -31,2018-12-13,-109.97500000000001,48.625,0.9698117455289992 -31,2018-12-14,-109.97500000000001,48.625,0.9698114819616321 -31,2018-12-15,-109.97500000000001,48.625,0.9698112183942652 -31,2018-12-16,-109.97500000000001,48.625,0.9698109548268982 -31,2018-12-17,-109.97500000000001,48.625,0.9698106912595312 -31,2018-12-18,-109.97500000000001,48.625,0.9698104276921642 -31,2018-12-19,-109.97500000000001,48.625,0.9698101641247971 -31,2018-12-20,-109.97500000000001,48.625,0.9698099005574302 -31,2018-12-21,-109.97500000000001,48.625,0.9698096369900632 -31,2018-12-22,-109.97500000000001,48.625,0.9698093734226962 -31,2018-12-23,-109.97500000000001,48.625,0.9698091098553292 -31,2018-12-24,-109.97500000000001,48.625,0.9698088462879622 -31,2018-12-25,-109.97500000000001,48.625,0.9698085827205952 -31,2018-12-26,-109.97500000000001,48.625,0.9698083191532282 -31,2018-12-27,-109.97500000000001,48.625,0.9698080555858613 -31,2018-12-28,-109.97500000000001,48.625,0.9698077920184942 -31,2018-12-29,-109.97500000000001,48.625,0.9698075284511272 -31,2018-12-30,-109.97500000000001,48.625,0.9698072648837602 -31,2018-12-31,-109.97500000000001,48.625,0.9698070013163932 -31,2019-01-01,-109.97500000000001,48.625,0.9698067377490263 -31,2019-01-02,-109.97500000000001,48.625,0.9698064741816592 -31,2019-01-03,-109.97500000000001,48.625,0.9698062106142922 -31,2019-01-04,-109.97500000000001,48.625,0.9698059470469252 -31,2019-01-05,-109.97500000000001,48.625,0.9698056006716603 -31,2019-01-06,-109.97500000000001,48.625,0.9698025541710316 -31,2019-01-07,-109.97500000000001,48.625,0.9697977256759565 -31,2019-01-08,-109.97500000000001,48.625,0.9697920145437934 -31,2019-01-09,-109.97500000000001,48.625,0.9697864899395467 -31,2019-01-10,-109.97500000000001,48.625,0.9697806656097905 -31,2019-01-11,-109.97500000000001,48.625,0.9697736391508323 -31,2019-01-12,-109.97500000000001,48.625,0.9697653739952594 -31,2019-01-13,-109.97500000000001,48.625,0.9697575278670867 -31,2019-01-14,-109.97500000000001,48.625,0.9697503245843552 -31,2019-01-15,-109.97500000000001,48.625,0.9697440163736365 -31,2019-01-16,-109.97500000000001,48.625,0.9697422476146904 -31,2019-01-17,-109.97500000000001,48.625,0.9697419840473235 -31,2019-01-18,-109.97500000000001,48.625,0.9697417204799564 -31,2019-01-19,-109.97500000000001,48.625,0.9697414569125895 -31,2019-01-20,-109.97500000000001,48.625,0.9697411933452225 -31,2019-01-21,-109.97500000000001,48.625,0.9697409297778554 -31,2019-01-22,-109.97500000000001,48.625,0.9697406662104885 -31,2019-01-23,-109.97500000000001,48.625,0.9697404026431214 -31,2019-01-24,-109.97500000000001,48.625,0.9697397913222381 -31,2019-01-25,-109.97500000000001,48.625,0.9697354006130874 -31,2019-01-26,-109.97500000000001,48.625,0.9697255549830194 -31,2019-01-27,-109.97500000000001,48.625,0.9697094286226485 -31,2019-01-28,-109.97500000000001,48.625,0.9697004336470648 -31,2019-01-29,-109.97500000000001,48.625,0.9697001700796978 -31,2019-01-30,-109.97500000000001,48.625,0.9696999065123307 -31,2019-01-31,-109.97500000000001,48.625,0.9696996429449638 -31,2019-02-01,-109.97500000000001,48.625,0.9696993793775968 -31,2019-02-02,-109.97500000000001,48.625,0.9696991420209752 -31,2019-02-03,-109.97500000000001,48.625,0.9696989046643535 -31,2019-02-04,-109.97500000000001,48.625,0.9696986673077319 -31,2019-02-05,-109.97500000000001,48.625,0.9696984299511103 -31,2019-02-06,-109.97500000000001,48.625,0.9696981925944886 -31,2019-02-07,-109.97500000000001,48.625,0.9696979552378671 -31,2019-02-08,-109.97500000000001,48.625,0.9696977178812454 -31,2019-02-09,-109.97500000000001,48.625,0.9696974805246238 -31,2019-02-10,-109.97500000000001,48.625,0.9696972431680022 -31,2019-02-11,-109.97500000000001,48.625,0.9696970058113805 -31,2019-02-12,-109.97500000000001,48.625,0.9696967684547589 -31,2019-02-13,-109.97500000000001,48.625,0.9696965310981372 -31,2019-02-14,-109.97500000000001,48.625,0.9696962937415157 -31,2019-02-15,-109.97500000000001,48.625,0.9696960563848941 -31,2019-02-16,-109.97500000000001,48.625,0.9696958190282724 -31,2019-02-17,-109.97500000000001,48.625,0.9696955816716508 -31,2019-02-18,-109.97500000000001,48.625,0.96969284787899 -31,2019-02-19,-109.97500000000001,48.625,0.9696831104442857 -31,2019-02-20,-109.97500000000001,48.625,0.969666734465275 -31,2019-02-21,-109.97500000000001,48.625,0.969643732562025 -31,2019-02-22,-109.97500000000001,48.625,0.9696134526870728 -31,2019-02-23,-109.97500000000001,48.625,0.9695761567024458 -31,2019-02-24,-109.97500000000001,48.625,0.9695330674020316 -31,2019-02-25,-109.97500000000001,48.625,0.969485030194486 -31,2019-02-26,-109.97500000000001,48.625,0.9694340867461941 -31,2019-02-27,-109.97500000000001,48.625,0.9693800279786599 -31,2019-02-28,-109.97500000000001,48.625,0.9693224018676693 -31,2019-03-01,-109.97500000000001,48.625,0.969260726409024 -31,2019-03-02,-109.97500000000001,48.625,0.9691943196635966 -31,2019-03-03,-109.97500000000001,48.625,0.9691249096489406 -31,2019-03-04,-109.97500000000001,48.625,0.9690541952071832 -31,2019-03-05,-109.97500000000001,48.625,0.9689822066913042 -31,2019-03-06,-109.97500000000001,48.625,0.9689083853170981 -31,2019-03-07,-109.97500000000001,48.625,0.9688326436411804 -31,2019-03-08,-109.97500000000001,48.625,0.9687548450999679 -31,2019-03-09,-109.97500000000001,48.625,0.9686743642662775 -31,2019-03-10,-109.97500000000001,48.625,0.9685914161290902 -31,2019-03-11,-109.97500000000001,48.625,0.9685066861605086 -31,2019-03-12,-109.97500000000001,48.625,0.968420239744759 -31,2019-03-13,-109.97500000000001,48.625,0.9683325461562031 -31,2019-03-14,-109.97500000000001,48.625,0.9682444949792113 -31,2019-03-15,-109.97500000000001,48.625,0.9681563989207502 -31,2019-03-16,-109.97500000000001,48.625,0.9680682979495668 -31,2019-03-17,-109.97500000000001,48.625,0.9679801965868863 -31,2019-03-18,-109.97500000000001,48.625,0.9678920950829202 -31,2019-03-19,-109.97500000000001,48.625,0.9678039934534659 -31,2019-03-20,-109.97500000000001,48.625,0.967715909043348 -31,2019-03-21,-109.97500000000001,48.625,0.9676307133666691 -31,2019-03-22,-109.97500000000001,48.625,0.9675647788397149 -31,2019-03-23,-109.97500000000001,48.625,0.9675327753052385 -31,2019-03-24,-109.97500000000001,48.625,0.9675322180086865 -31,2019-03-25,-109.97500000000001,48.625,0.9675319544413195 -31,2019-03-26,-109.97500000000001,48.625,0.9675316908739525 -31,2019-03-27,-109.97500000000001,48.625,0.9675314273065855 -31,2019-03-28,-109.97500000000001,48.625,0.9675311637392185 -31,2019-03-29,-109.97500000000001,48.625,0.9675309001718515 -31,2019-03-30,-109.97500000000001,48.625,0.9675306366044846 -31,2019-03-31,-109.97500000000001,48.625,0.9675303730371175 -31,2019-04-01,-109.97500000000001,48.625,0.9675301094697505 -31,2019-04-02,-109.97500000000001,48.625,0.9675297609733782 -31,2019-04-03,-109.97500000000001,48.625,0.967529412477006 -31,2019-04-04,-109.97500000000001,48.625,0.9675290639806337 -31,2019-04-05,-109.97500000000001,48.625,0.9675287154842613 -31,2019-04-06,-109.97500000000001,48.625,0.967528366987889 -31,2019-04-07,-109.97500000000001,48.625,0.9675280184915167 -31,2019-04-08,-109.97500000000001,48.625,0.9675276699951444 -31,2019-04-09,-109.97500000000001,48.625,0.9675273214987721 -31,2019-04-10,-109.97500000000001,48.625,0.9675269730023998 -31,2019-04-11,-109.97500000000001,48.625,0.9675266245060276 -31,2019-04-12,-109.97500000000001,48.625,0.9675262760096552 -31,2019-04-13,-109.97500000000001,48.625,0.9675259275132829 -31,2019-04-14,-109.97500000000001,48.625,0.9675255790169106 -31,2019-04-15,-109.97500000000001,48.625,0.9675252305205383 -31,2019-04-16,-109.97500000000001,48.625,0.967524882024166 -31,2019-04-17,-109.97500000000001,48.625,0.9675245335277937 -31,2019-04-18,-109.97500000000001,48.625,0.9675241850314213 -31,2019-04-19,-109.97500000000001,48.625,0.967523836535049 -31,2019-04-20,-109.97500000000001,48.625,0.9675234880386768 -31,2019-04-21,-109.97500000000001,48.625,0.9675231395423045 -31,2019-04-22,-109.97500000000001,48.625,0.9675227910459322 -31,2019-04-23,-109.97500000000001,48.625,0.9675224425495599 -31,2019-04-24,-109.97500000000001,48.625,0.9675220940531876 -31,2019-04-25,-109.97500000000001,48.625,0.9675217455568152 -31,2019-04-26,-109.97500000000001,48.625,0.9675213970604429 -31,2019-04-27,-109.97500000000001,48.625,0.9675210485640706 -31,2019-04-28,-109.97500000000001,48.625,0.9675207000676984 -31,2019-04-29,-109.97500000000001,48.625,0.9675203515713261 -31,2019-04-30,-109.97500000000001,48.625,0.9675200030749538 -31,2019-05-01,-109.97500000000001,48.625,0.9675196545785815 -31,2019-05-02,-109.97500000000001,48.625,0.9675193060822092 -31,2019-05-03,-109.97500000000001,48.625,0.9675189575858368 -31,2019-05-04,-109.97500000000001,48.625,0.9675186090894645 -31,2019-05-05,-109.97500000000001,48.625,0.9675182605930922 -31,2019-05-06,-109.97500000000001,48.625,0.9675179120967199 -31,2019-05-07,-109.97500000000001,48.625,0.9675175636003477 -31,2019-05-08,-109.97500000000001,48.625,0.9675172151039754 -31,2019-05-09,-109.97500000000001,48.625,0.967516866607603 -31,2019-05-10,-109.97500000000001,48.625,0.9675165181112307 -31,2019-05-11,-109.97500000000001,48.625,0.9675161696148584 -31,2019-05-12,-109.97500000000001,48.625,0.9675158211184861 -31,2019-05-13,-109.97500000000001,48.625,0.9675153726294513 -31,2019-05-14,-109.97500000000001,48.625,0.9675149014127871 -31,2019-05-15,-109.97500000000001,48.625,0.9675144295311199 -31,2019-05-16,-109.97500000000001,48.625,0.9675134101183392 -31,2019-05-17,-109.97500000000001,48.625,0.9675130616219669 -31,2019-05-18,-109.97500000000001,48.625,0.9675127131255946 -31,2019-05-19,-109.97500000000001,48.625,0.9675123646292223 -31,2019-05-20,-109.97500000000001,48.625,0.9675120161328501 -31,2019-05-21,-109.97500000000001,48.625,0.9675116676364778 -31,2019-05-22,-109.97500000000001,48.625,0.9675113191401055 -31,2019-05-23,-109.97500000000001,48.625,0.9675109706437331 -31,2019-05-24,-109.97500000000001,48.625,0.9675106221473608 -31,2019-05-25,-109.97500000000001,48.625,0.9675102736509885 -31,2019-05-26,-109.97500000000001,48.625,0.9675099251546162 -31,2019-05-27,-109.97500000000001,48.625,0.9675095766582439 -31,2019-05-28,-109.97500000000001,48.625,0.9675092281618717 -31,2019-05-29,-109.97500000000001,48.625,0.9675088796654994 -31,2019-05-30,-109.97500000000001,48.625,0.9675085304005645 -31,2019-05-31,-109.97500000000001,48.625,0.9675081789733682 -31,2019-06-01,-109.97500000000001,48.625,0.967507830476996 -31,2019-06-02,-109.97500000000001,48.625,0.9675073903188588 -31,2019-06-03,-109.97500000000001,48.625,0.9675068180701226 -31,2019-06-04,-109.97500000000001,48.625,0.967505894978253 -31,2019-06-05,-109.97500000000001,48.625,0.9675046268047617 -31,2019-06-06,-109.97500000000001,48.625,0.9675031588854828 -31,2019-06-07,-109.97500000000001,48.625,0.9675025614567936 -31,2019-06-08,-109.97500000000001,48.625,0.9675020752501857 -31,2019-06-09,-109.97500000000001,48.625,0.9675016646877348 -31,2019-06-10,-109.97500000000001,48.625,0.9675007824607245 -31,2019-06-11,-109.97500000000001,48.625,0.9675002938781653 -31,2019-06-12,-109.97500000000001,48.625,0.9674998736119191 -31,2019-06-13,-109.97500000000001,48.625,0.9674989545293049 -31,2019-06-14,-109.97500000000001,48.625,0.967497296442857 -31,2019-06-15,-109.97500000000001,48.625,0.967496885880406 -31,2019-06-16,-109.97500000000001,48.625,0.9674964586729599 -31,2019-06-17,-109.97500000000001,48.625,0.9674953170697248 -31,2019-06-18,-109.97500000000001,48.625,0.9674945165353578 -31,2019-06-19,-109.97500000000001,48.625,0.967494105972907 -31,2019-06-20,-109.97500000000001,48.625,0.9674921060621741 -31,2019-06-21,-109.97500000000001,48.625,0.9674916954997231 -31,2019-06-22,-109.97500000000001,48.625,0.9674912849372723 -31,2019-06-23,-109.97500000000001,48.625,0.9674903340726981 -31,2019-06-24,-109.97500000000001,48.625,0.9674893240555205 -31,2019-06-25,-109.97500000000001,48.625,0.9674889134930696 -31,2019-06-26,-109.97500000000001,48.625,0.9674883671091451 -31,2019-06-27,-109.97500000000001,48.625,0.9674872767990681 -31,2019-06-28,-109.97500000000001,48.625,0.9674868662366172 -31,2019-06-29,-109.97500000000001,48.625,0.9674864221706069 -31,2019-06-30,-109.97500000000001,48.625,0.9674834439853959 -31,2019-07-01,-109.97500000000001,48.625,0.9674815109626722 -31,2019-07-02,-109.97500000000001,48.625,0.9674796936373498 -31,2019-07-03,-109.97500000000001,48.625,0.9674792830748989 -31,2019-07-04,-109.97500000000001,48.625,0.967478872512448 -31,2019-07-05,-109.97500000000001,48.625,0.9674784619499971 -31,2019-07-06,-109.97500000000001,48.625,0.9674780513875463 -31,2019-07-07,-109.97500000000001,48.625,0.9674768773989402 -31,2019-07-08,-109.97500000000001,48.625,0.9674764668364892 -31,2019-07-09,-109.97500000000001,48.625,0.9674746826064093 -31,2019-07-10,-109.97500000000001,48.625,0.9674741323743715 -31,2019-07-11,-109.97500000000001,48.625,0.9674717189499374 -31,2019-07-12,-109.97500000000001,48.625,0.9674707925263671 -31,2019-07-13,-109.97500000000001,48.625,0.9674667263602204 -31,2019-07-14,-109.97500000000001,48.625,0.9674635166927175 -31,2019-07-15,-109.97500000000001,48.625,0.9674605855214381 -31,2019-07-16,-109.97500000000001,48.625,0.9674575781002068 -31,2019-07-17,-109.97500000000001,48.625,0.9674561263091374 -31,2019-07-18,-109.97500000000001,48.625,0.9674547772284671 -31,2019-07-19,-109.97500000000001,48.625,0.9674524610353331 -31,2019-07-20,-109.97500000000001,48.625,0.9674506761399515 -31,2019-07-21,-109.97500000000001,48.625,0.9674502409846125 -31,2019-07-22,-109.97500000000001,48.625,0.9674493578768164 -31,2019-07-23,-109.97500000000001,48.625,0.9674452674851381 -31,2019-07-24,-109.97500000000001,48.625,0.9674399682027726 -31,2019-07-25,-109.97500000000001,48.625,0.9674350527492964 -31,2019-07-26,-109.97500000000001,48.625,0.9674299324773743 -31,2019-07-27,-109.97500000000001,48.625,0.9674258489094811 -31,2019-07-28,-109.97500000000001,48.625,0.9674205891241808 -31,2019-07-29,-109.97500000000001,48.625,0.9674165846931273 -31,2019-07-30,-109.97500000000001,48.625,0.9674122871156633 -31,2019-07-31,-109.97500000000001,48.625,0.9674099107652785 -31,2019-08-01,-109.97500000000001,48.625,0.9674072730218851 -31,2019-08-02,-109.97500000000001,48.625,0.9674037579196189 -31,2019-08-03,-109.97500000000001,48.625,0.967400043158522 -31,2019-08-04,-109.97500000000001,48.625,0.9673964530504875 -31,2019-08-05,-109.97500000000001,48.625,0.9673933858002214 -31,2019-08-06,-109.97500000000001,48.625,0.9673903330691987 -31,2019-08-07,-109.97500000000001,48.625,0.9673879476182888 -31,2019-08-08,-109.97500000000001,48.625,0.9673866956082604 -31,2019-08-09,-109.97500000000001,48.625,0.9673832840003042 -31,2019-08-10,-109.97500000000001,48.625,0.967382589105609 -31,2019-08-11,-109.97500000000001,48.625,0.9673821785431582 -31,2019-08-12,-109.97500000000001,48.625,0.9673817679807073 -31,2019-08-13,-109.97500000000001,48.625,0.9673813574182564 -31,2019-08-14,-109.97500000000001,48.625,0.9673809468558056 -31,2019-08-15,-109.97500000000001,48.625,0.9673804742479688 -31,2019-08-16,-109.97500000000001,48.625,0.9673776526587256 -31,2019-08-17,-109.97500000000001,48.625,0.9673767289481068 -31,2019-08-18,-109.97500000000001,48.625,0.9673763183856559 -31,2019-08-19,-109.97500000000001,48.625,0.967375391006122 -31,2019-08-20,-109.97500000000001,48.625,0.9673745070271996 -31,2019-08-21,-109.97500000000001,48.625,0.9673738292191381 -31,2019-08-22,-109.97500000000001,48.625,0.9673720214933751 -31,2019-08-23,-109.97500000000001,48.625,0.9673716109309242 -31,2019-08-24,-109.97500000000001,48.625,0.9673712003684733 -31,2019-08-25,-109.97500000000001,48.625,0.9673704429204144 -31,2019-08-26,-109.97500000000001,48.625,0.9673700323579635 -31,2019-08-27,-109.97500000000001,48.625,0.9673696217955127 -31,2019-08-28,-109.97500000000001,48.625,0.9673692112330617 -31,2019-08-29,-109.97500000000001,48.625,0.9673682223847667 -31,2019-08-30,-109.97500000000001,48.625,0.9673678118223159 -31,2019-08-31,-109.97500000000001,48.625,0.967367401259865 -31,2019-09-01,-109.97500000000001,48.625,0.9673664105109968 -31,2019-09-02,-109.97500000000001,48.625,0.9673659943033339 -31,2019-09-03,-109.97500000000001,48.625,0.9673655788066003 -31,2019-09-04,-109.97500000000001,48.625,0.967364660019333 -31,2019-09-05,-109.97500000000001,48.625,0.967363142414586 -31,2019-09-06,-109.97500000000001,48.625,0.9673618393423915 -31,2019-09-07,-109.97500000000001,48.625,0.9673614287799406 -31,2019-09-08,-109.97500000000001,48.625,0.9673610182174898 -31,2019-09-09,-109.97500000000001,48.625,0.9673606076550388 -31,2019-09-10,-109.97500000000001,48.625,0.9673601970925879 -31,2019-09-11,-109.97500000000001,48.625,0.9673597865301371 -31,2019-09-12,-109.97500000000001,48.625,0.9673593759676862 -31,2019-09-13,-109.97500000000001,48.625,0.9673589654052352 -31,2019-09-14,-109.97500000000001,48.625,0.9673585548427844 -31,2019-09-15,-109.97500000000001,48.625,0.9673581442803335 -31,2019-09-16,-109.97500000000001,48.625,0.9673570899867008 -31,2019-09-17,-109.97500000000001,48.625,0.96735667942425 -31,2019-09-18,-109.97500000000001,48.625,0.967356268861799 -31,2019-09-19,-109.97500000000001,48.625,0.9673558582993481 -31,2019-09-20,-109.97500000000001,48.625,0.9673554477368973 -31,2019-09-21,-109.97500000000001,48.625,0.9673550371744464 -31,2019-09-22,-109.97500000000001,48.625,0.9673546266119954 -31,2019-09-23,-109.97500000000001,48.625,0.9673542160495446 -31,2019-09-24,-109.97500000000001,48.625,0.9673538054870937 -31,2019-09-25,-109.97500000000001,48.625,0.9673533949246429 -31,2019-09-26,-109.97500000000001,48.625,0.967352984362192 -31,2019-09-27,-109.97500000000001,48.625,0.967352573799741 -31,2019-09-28,-109.97500000000001,48.625,0.9673521632372902 -31,2019-09-29,-109.97500000000001,48.625,0.9673517526748393 -31,2019-09-30,-109.97500000000001,48.625,0.9673513421123884 -31,2019-10-01,-109.97500000000001,48.625,0.9673509315499376 -31,2019-10-02,-109.97500000000001,48.625,0.9673506433288896 -31,2019-10-03,-109.97500000000001,48.625,0.9673503551078417 -31,2019-10-04,-109.97500000000001,48.625,0.9673500668867938 -31,2019-10-05,-109.97500000000001,48.625,0.9673497786657459 -31,2019-10-06,-109.97500000000001,48.625,0.967349490444698 -31,2019-10-07,-109.97500000000001,48.625,0.9673492022236501 -31,2019-10-08,-109.97500000000001,48.625,0.9673489140026021 -31,2019-10-09,-109.97500000000001,48.625,0.9673486257815542 -31,2019-10-10,-109.97500000000001,48.625,0.9673483375605063 -31,2019-10-11,-109.97500000000001,48.625,0.9673480493394584 -31,2019-10-12,-109.97500000000001,48.625,0.9673477611184105 -31,2019-10-13,-109.97500000000001,48.625,0.9673474728973626 -31,2019-10-14,-109.97500000000001,48.625,0.9673471846763146 -31,2019-10-15,-109.97500000000001,48.625,0.9673468964552667 -31,2019-10-16,-109.97500000000001,48.625,0.9673466082342188 -31,2019-10-17,-109.97500000000001,48.625,0.9673463200131709 -31,2019-10-18,-109.97500000000001,48.625,0.967346031792123 -31,2019-10-19,-109.97500000000001,48.625,0.9673457435710751 -31,2019-10-20,-109.97500000000001,48.625,0.9673454553500271 -31,2019-10-21,-109.97500000000001,48.625,0.9673451671289791 -31,2019-10-22,-109.97500000000001,48.625,0.9673448789079312 -31,2019-10-23,-109.97500000000001,48.625,0.9673445906868833 -31,2019-10-24,-109.97500000000001,48.625,0.9673443024658354 -31,2019-10-25,-109.97500000000001,48.625,0.9673440142447874 -31,2019-10-26,-109.97500000000001,48.625,0.9673437260237395 -31,2019-10-27,-109.97500000000001,48.625,0.9673434378026916 -31,2019-10-28,-109.97500000000001,48.625,0.9673431495816437 -31,2019-10-29,-109.97500000000001,48.625,0.9673428613605958 -31,2019-10-30,-109.97500000000001,48.625,0.9673425731395479 -31,2019-10-31,-109.97500000000001,48.625,0.9673422849184999 -31,2019-11-01,-109.97500000000001,48.625,0.967341996697452 -31,2019-11-02,-109.97500000000001,48.625,0.9673417084764041 -31,2019-11-03,-109.97500000000001,48.625,0.9673414202553562 -31,2019-11-04,-109.97500000000001,48.625,0.9673411320343083 -31,2019-11-05,-109.97500000000001,48.625,0.9673408438132604 -31,2019-11-06,-109.97500000000001,48.625,0.9673405555922124 -31,2019-11-07,-109.97500000000001,48.625,0.9673402673711645 -31,2019-11-08,-109.97500000000001,48.625,0.9673399791501166 -31,2019-11-09,-109.97500000000001,48.625,0.9673396909290687 -31,2019-11-10,-109.97500000000001,48.625,0.9673394027080208 -31,2019-11-11,-109.97500000000001,48.625,0.9673391144869729 -31,2019-11-12,-109.97500000000001,48.625,0.9673388262659249 -31,2019-11-13,-109.97500000000001,48.625,0.967338538044877 -31,2019-11-14,-109.97500000000001,48.625,0.9673382498238291 -31,2019-11-15,-109.97500000000001,48.625,0.9673379616027812 -31,2019-11-16,-109.97500000000001,48.625,0.9673376733817333 -31,2019-11-17,-109.97500000000001,48.625,0.9673373851606853 -31,2019-11-18,-109.97500000000001,48.625,0.9673370969396374 -31,2019-11-19,-109.97500000000001,48.625,0.9673368087185895 -31,2019-11-20,-109.97500000000001,48.625,0.9673365204975416 -31,2019-11-21,-109.97500000000001,48.625,0.9673362322764937 -31,2019-11-22,-109.97500000000001,48.625,0.9673359440554458 -31,2019-11-23,-109.97500000000001,48.625,0.9673356558343978 -31,2019-11-24,-109.97500000000001,48.625,0.9673353676133499 -31,2019-11-25,-109.97500000000001,48.625,0.967335079392302 -31,2019-11-26,-109.97500000000001,48.625,0.9673347911712541 -31,2019-11-27,-109.97500000000001,48.625,0.9673345029502062 -31,2019-11-28,-109.97500000000001,48.625,0.9673342147291583 -31,2019-11-29,-109.97500000000001,48.625,0.9673339265081103 -31,2019-11-30,-109.97500000000001,48.625,0.9673336382870624 -31,2019-12-01,-109.97500000000001,48.625,0.9673333500660145 -31,2019-12-02,-109.97500000000001,48.625,0.9673330751091581 -31,2019-12-03,-109.97500000000001,48.625,0.9673328001523018 -31,2019-12-04,-109.97500000000001,48.625,0.9673325251954454 -31,2019-12-05,-109.97500000000001,48.625,0.967332250238589 -31,2019-12-06,-109.97500000000001,48.625,0.9673319752817326 -31,2019-12-07,-109.97500000000001,48.625,0.9673317003248763 -31,2019-12-08,-109.97500000000001,48.625,0.96733142536802 -31,2019-12-09,-109.97500000000001,48.625,0.9673311504111636 -31,2019-12-10,-109.97500000000001,48.625,0.9673308754543072 -31,2019-12-11,-109.97500000000001,48.625,0.9673306004974508 -31,2019-12-12,-109.97500000000001,48.625,0.9673303255405945 -31,2019-12-13,-109.97500000000001,48.625,0.9673300505837381 -31,2019-12-14,-109.97500000000001,48.625,0.9673297756268817 -31,2019-12-15,-109.97500000000001,48.625,0.9673295006700253 -31,2019-12-16,-109.97500000000001,48.625,0.9673292257131689 -31,2019-12-17,-109.97500000000001,48.625,0.9673289507563126 -31,2019-12-18,-109.97500000000001,48.625,0.9673286757994563 -31,2019-12-19,-109.97500000000001,48.625,0.9673284008425999 -31,2019-12-20,-109.97500000000001,48.625,0.9673281258857435 -31,2019-12-21,-109.97500000000001,48.625,0.9673278509288872 -31,2019-12-22,-109.97500000000001,48.625,0.9673275759720308 -31,2019-12-23,-109.97500000000001,48.625,0.9673273010151744 -31,2019-12-24,-109.97500000000001,48.625,0.967327026058318 -31,2019-12-25,-109.97500000000001,48.625,0.9673267511014616 -31,2019-12-26,-109.97500000000001,48.625,0.9673264761446053 -31,2019-12-27,-109.97500000000001,48.625,0.9673262011877489 -31,2019-12-28,-109.97500000000001,48.625,0.9673259262308925 -31,2019-12-29,-109.97500000000001,48.625,0.9673256512740361 -31,2019-12-30,-109.97500000000001,48.625,0.9673253763171799 -31,2019-12-31,-109.97500000000001,48.625,0.9673251013603235 -31,2020-01-01,-109.97500000000001,48.625,0.9673248264034671 -48,2018-01-02,-111.325,44.825,0.9683853283910147 -48,2018-01-03,-111.325,44.825,0.9683815081025451 -48,2018-01-04,-111.325,44.825,0.9683776878140755 -48,2018-01-05,-111.325,44.825,0.968373867525606 -48,2018-01-06,-111.325,44.825,0.9683700472371364 -48,2018-01-07,-111.325,44.825,0.9683662269486668 -48,2018-01-08,-111.325,44.825,0.9683624066601971 -48,2018-01-09,-111.325,44.825,0.9683585863717276 -48,2018-01-10,-111.325,44.825,0.968354766083258 -48,2018-01-11,-111.325,44.825,0.9683509457947884 -48,2018-01-12,-111.325,44.825,0.9683471255063189 -48,2018-01-13,-111.325,44.825,0.9683433052178493 -48,2018-01-14,-111.325,44.825,0.9683394849293797 -48,2018-01-15,-111.325,44.825,0.9683356646409101 -48,2018-01-16,-111.325,44.825,0.9683318443524406 -48,2018-01-17,-111.325,44.825,0.968328024063971 -48,2018-01-18,-111.325,44.825,0.9683242037755014 -48,2018-01-19,-111.325,44.825,0.9683203834870319 -48,2018-01-20,-111.325,44.825,0.9683165631985623 -48,2018-01-21,-111.325,44.825,0.9683127429100927 -48,2018-01-22,-111.325,44.825,0.9683089226216232 -48,2018-01-23,-111.325,44.825,0.9683051023331536 -48,2018-01-24,-111.325,44.825,0.968301282044684 -48,2018-01-25,-111.325,44.825,0.9682974617562145 -48,2018-01-26,-111.325,44.825,0.9682936414677449 -48,2018-01-27,-111.325,44.825,0.9682898211792753 -48,2018-01-28,-111.325,44.825,0.9682860008908056 -48,2018-01-29,-111.325,44.825,0.9682821806023361 -48,2018-01-30,-111.325,44.825,0.9682783603138665 -48,2018-01-31,-111.325,44.825,0.9682745400253969 -48,2018-02-01,-111.325,44.825,0.9682707197369274 -48,2018-02-02,-111.325,44.825,0.9682668869729727 -48,2018-02-03,-111.325,44.825,0.9682630542090179 -48,2018-02-04,-111.325,44.825,0.9682592214450632 -48,2018-02-05,-111.325,44.825,0.9682553886811085 -48,2018-02-06,-111.325,44.825,0.9682515559171537 -48,2018-02-07,-111.325,44.825,0.9682477231531991 -48,2018-02-08,-111.325,44.825,0.9682438903892443 -48,2018-02-09,-111.325,44.825,0.9682400576252895 -48,2018-02-10,-111.325,44.825,0.9682362248613349 -48,2018-02-11,-111.325,44.825,0.9682323920973801 -48,2018-02-12,-111.325,44.825,0.9682285593334254 -48,2018-02-13,-111.325,44.825,0.9682247265694707 -48,2018-02-14,-111.325,44.825,0.9682208938055159 -48,2018-02-15,-111.325,44.825,0.9682170610415612 -48,2018-02-16,-111.325,44.825,0.9682132282776065 -48,2018-02-17,-111.325,44.825,0.9682093955136518 -48,2018-02-18,-111.325,44.825,0.968205562749697 -48,2018-02-19,-111.325,44.825,0.9682017299857423 -48,2018-02-20,-111.325,44.825,0.9681978972217876 -48,2018-02-21,-111.325,44.825,0.9681940644578328 -48,2018-02-22,-111.325,44.825,0.9681902316938782 -48,2018-02-23,-111.325,44.825,0.9681863989299234 -48,2018-02-24,-111.325,44.825,0.9681825661659686 -48,2018-02-25,-111.325,44.825,0.968178733402014 -48,2018-02-26,-111.325,44.825,0.9681749006380592 -48,2018-02-27,-111.325,44.825,0.9681710678741045 -48,2018-02-28,-111.325,44.825,0.9681672351101498 -48,2018-03-01,-111.325,44.825,0.968163402346195 -48,2018-03-02,-111.325,44.825,0.9681593131312535 -48,2018-03-03,-111.325,44.825,0.9681552239163119 -48,2018-03-04,-111.325,44.825,0.9681511347013703 -48,2018-03-05,-111.325,44.825,0.9681470454864287 -48,2018-03-06,-111.325,44.825,0.9681429562714872 -48,2018-03-07,-111.325,44.825,0.9681388670565455 -48,2018-03-08,-111.325,44.825,0.968134777841604 -48,2018-03-09,-111.325,44.825,0.9681306886266623 -48,2018-03-10,-111.325,44.825,0.9681265994117207 -48,2018-03-11,-111.325,44.825,0.9681225101967792 -48,2018-03-12,-111.325,44.825,0.9681184209818375 -48,2018-03-13,-111.325,44.825,0.968114331766896 -48,2018-03-14,-111.325,44.825,0.9681102425519544 -48,2018-03-15,-111.325,44.825,0.9681061533370128 -48,2018-03-16,-111.325,44.825,0.9681020641220712 -48,2018-03-17,-111.325,44.825,0.9680979749071297 -48,2018-03-18,-111.325,44.825,0.968093885692188 -48,2018-03-19,-111.325,44.825,0.9680897964772465 -48,2018-03-20,-111.325,44.825,0.9680857072623049 -48,2018-03-21,-111.325,44.825,0.9680816180473633 -48,2018-03-22,-111.325,44.825,0.9680775288324217 -48,2018-03-23,-111.325,44.825,0.9680734396174802 -48,2018-03-24,-111.325,44.825,0.9680693504025385 -48,2018-03-25,-111.325,44.825,0.968065261187597 -48,2018-03-26,-111.325,44.825,0.9680611719726554 -48,2018-03-27,-111.325,44.825,0.9680570827577137 -48,2018-03-28,-111.325,44.825,0.9680529935427722 -48,2018-03-29,-111.325,44.825,0.9680489043278305 -48,2018-03-30,-111.325,44.825,0.968044815112889 -48,2018-03-31,-111.325,44.825,0.9680407258979474 -48,2018-04-01,-111.325,44.825,0.9680366366830058 -48,2018-04-02,-111.325,44.825,0.9680321368520975 -48,2018-04-03,-111.325,44.825,0.9680276370211892 -48,2018-04-04,-111.325,44.825,0.9680231371902809 -48,2018-04-05,-111.325,44.825,0.9680186373593725 -48,2018-04-06,-111.325,44.825,0.9680141375284643 -48,2018-04-07,-111.325,44.825,0.968009637697556 -48,2018-04-08,-111.325,44.825,0.9680051378666477 -48,2018-04-09,-111.325,44.825,0.9680006380357393 -48,2018-04-10,-111.325,44.825,0.9679961382048311 -48,2018-04-11,-111.325,44.825,0.9679916383739228 -48,2018-04-12,-111.325,44.825,0.9679871385430144 -48,2018-04-13,-111.325,44.825,0.9679826387121061 -48,2018-04-14,-111.325,44.825,0.9679781388811979 -48,2018-04-15,-111.325,44.825,0.9679736390502895 -48,2018-04-16,-111.325,44.825,0.9679691392193812 -48,2018-04-17,-111.325,44.825,0.9679646393884729 -48,2018-04-18,-111.325,44.825,0.9679601395575647 -48,2018-04-19,-111.325,44.825,0.9679556397266563 -48,2018-04-20,-111.325,44.825,0.967951139895748 -48,2018-04-21,-111.325,44.825,0.9679466400648397 -48,2018-04-22,-111.325,44.825,0.9679421402339314 -48,2018-04-23,-111.325,44.825,0.9679376404030231 -48,2018-04-24,-111.325,44.825,0.9679331405721148 -48,2018-04-25,-111.325,44.825,0.9679286407412064 -48,2018-04-26,-111.325,44.825,0.9679241409102982 -48,2018-04-27,-111.325,44.825,0.9679196410793899 -48,2018-04-28,-111.325,44.825,0.9679151412484815 -48,2018-04-29,-111.325,44.825,0.9676823265178227 -48,2018-04-30,-111.325,44.825,0.9674622223151824 -48,2018-05-01,-111.325,44.825,0.9667871410525353 -48,2018-05-02,-111.325,44.825,0.9663663670352834 -48,2018-05-03,-111.325,44.825,0.9657999285129307 -48,2018-05-04,-111.325,44.825,0.9655568201081594 -48,2018-05-05,-111.325,44.825,0.9650252601037805 -48,2018-05-06,-111.325,44.825,0.9646504210301612 -48,2018-05-07,-111.325,44.825,0.9645034697854323 -48,2018-05-08,-111.325,44.825,0.9645940427759839 -48,2018-05-09,-111.325,44.825,0.9649923116128434 -48,2018-05-10,-111.325,44.825,0.9657731561003152 -48,2018-05-11,-111.325,44.825,0.967026628211752 -48,2018-05-12,-111.325,44.825,0.9690049622285317 -48,2018-05-13,-111.325,44.825,0.971672951658018 -48,2018-05-14,-111.325,44.825,0.9745231660240903 -48,2018-05-15,-111.325,44.825,0.9774443422532166 -48,2018-05-16,-111.325,44.825,0.9803577831607881 -48,2018-05-17,-111.325,44.825,0.9832851190288544 -48,2018-05-18,-111.325,44.825,0.9853590740161906 -48,2018-05-19,-111.325,44.825,0.9862958439620811 -48,2018-05-20,-111.325,44.825,0.9868081718375903 -48,2018-05-21,-111.325,44.825,0.9870690726703555 -48,2018-05-22,-111.325,44.825,0.9872155893478705 -48,2018-05-23,-111.325,44.825,0.9874654115929759 -48,2018-05-24,-111.325,44.825,0.9882805332674078 -48,2018-05-25,-111.325,44.825,0.9888863060915909 -48,2018-05-26,-111.325,44.825,0.9895313133958157 -48,2018-05-27,-111.325,44.825,0.9907912485261872 -48,2018-05-28,-111.325,44.825,0.9927379092242979 -48,2018-05-29,-111.325,44.825,0.9947248772336769 -48,2018-05-30,-111.325,44.825,0.9963395121575939 -48,2018-05-31,-111.325,44.825,0.99731041151237 -48,2018-06-01,-111.325,44.825,0.9980960728246494 -48,2018-06-02,-111.325,44.825,0.9993805623995693 -48,2018-06-03,-111.325,44.825,0.9992628977865469 -48,2018-06-04,-111.325,44.825,0.9984280447396265 -48,2018-06-05,-111.325,44.825,0.9978746745478485 -48,2018-06-06,-111.325,44.825,0.9978450704845893 -48,2018-06-07,-111.325,44.825,0.9975430043022873 -48,2018-06-08,-111.325,44.825,0.9965114186676867 -48,2018-06-09,-111.325,44.825,0.9951203884334853 -48,2018-06-10,-111.325,44.825,0.9937731759753387 -48,2018-06-11,-111.325,44.825,0.9925596024077251 -48,2018-06-12,-111.325,44.825,0.9914462544735244 -48,2018-06-13,-111.325,44.825,0.9904104173457675 -48,2018-06-14,-111.325,44.825,0.9894615846459742 -48,2018-06-15,-111.325,44.825,0.9886055992838689 -48,2018-06-16,-111.325,44.825,0.9879290770412306 -48,2018-06-17,-111.325,44.825,0.9873799764666829 -48,2018-06-18,-111.325,44.825,0.987107775784102 -48,2018-06-19,-111.325,44.825,0.9872435190625115 -48,2018-06-20,-111.325,44.825,0.9871746045527662 -48,2018-06-21,-111.325,44.825,0.9870241602624472 -48,2018-06-22,-111.325,44.825,0.9867681685544138 -48,2018-06-23,-111.325,44.825,0.9864217413094218 -48,2018-06-24,-111.325,44.825,0.9859881336871867 -48,2018-06-25,-111.325,44.825,0.9856740418993791 -48,2018-06-26,-111.325,44.825,0.9852765436025777 -48,2018-06-27,-111.325,44.825,0.9848074313493169 -48,2018-06-28,-111.325,44.825,0.984382713710807 -48,2018-06-29,-111.325,44.825,0.9840474862853074 -48,2018-06-30,-111.325,44.825,0.9839231405462509 -48,2018-07-01,-111.325,44.825,0.983763196117681 -48,2018-07-02,-111.325,44.825,0.9834400015349049 -48,2018-07-03,-111.325,44.825,0.9828446469026235 -48,2018-07-04,-111.325,44.825,0.9821044330879601 -48,2018-07-05,-111.325,44.825,0.9814070463181888 -48,2018-07-06,-111.325,44.825,0.9807537338384865 -48,2018-07-07,-111.325,44.825,0.9801468818182342 -48,2018-07-08,-111.325,44.825,0.9795774133839723 -48,2018-07-09,-111.325,44.825,0.9790378135263156 -48,2018-07-10,-111.325,44.825,0.9785236955415343 -48,2018-07-11,-111.325,44.825,0.9780301933086492 -48,2018-07-12,-111.325,44.825,0.9775563768227443 -48,2018-07-13,-111.325,44.825,0.977099551866794 -48,2018-07-14,-111.325,44.825,0.976658748380715 -48,2018-07-15,-111.325,44.825,0.9762334298329911 -48,2018-07-16,-111.325,44.825,0.9758184877237788 -48,2018-07-17,-111.325,44.825,0.9754090430168855 -48,2018-07-18,-111.325,44.825,0.9750042263088884 -48,2018-07-19,-111.325,44.825,0.974608216827293 -48,2018-07-20,-111.325,44.825,0.9742237277266813 -48,2018-07-21,-111.325,44.825,0.9738507270929371 -48,2018-07-22,-111.325,44.825,0.9734822427922045 -48,2018-07-23,-111.325,44.825,0.9731165106360409 -48,2018-07-24,-111.325,44.825,0.9727562505629888 -48,2018-07-25,-111.325,44.825,0.9724002477207139 -48,2018-07-26,-111.325,44.825,0.9720434744967504 -48,2018-07-27,-111.325,44.825,0.9716894482954688 -48,2018-07-28,-111.325,44.825,0.9713408579322665 -48,2018-07-29,-111.325,44.825,0.9709930648641502 -48,2018-07-30,-111.325,44.825,0.9706467044947364 -48,2018-07-31,-111.325,44.825,0.9703045297083379 -48,2018-08-01,-111.325,44.825,0.9699669808205543 -48,2018-08-02,-111.325,44.825,0.9696837544990538 -48,2018-08-03,-111.325,44.825,0.9696780614390115 -48,2018-08-04,-111.325,44.825,0.9696723953530942 -48,2018-08-05,-111.325,44.825,0.9696666708183719 -48,2018-08-06,-111.325,44.825,0.9696609796154209 -48,2018-08-07,-111.325,44.825,0.9696553135295035 -48,2018-08-08,-111.325,44.825,0.9696495565027642 -48,2018-08-09,-111.325,44.825,0.9696430190417521 -48,2018-08-10,-111.325,44.825,0.9696363228542826 -48,2018-08-11,-111.325,44.825,0.9696291923125949 -48,2018-08-12,-111.325,44.825,0.9696222151914674 -48,2018-08-13,-111.325,44.825,0.9696157391392938 -48,2018-08-14,-111.325,44.825,0.9696082654471051 -48,2018-08-15,-111.325,44.825,0.9696021733518324 -48,2018-08-16,-111.325,44.825,0.9695944892159697 -48,2018-08-17,-111.325,44.825,0.9695875306281566 -48,2018-08-18,-111.325,44.825,0.9695793479882325 -48,2018-08-19,-111.325,44.825,0.9695733629385924 -48,2018-08-20,-111.325,44.825,0.9695673732946544 -48,2018-08-21,-111.325,44.825,0.9695617072087371 -48,2018-08-22,-111.325,44.825,0.9695560411228198 -48,2018-08-23,-111.325,44.825,0.9695503750369024 -48,2018-08-24,-111.325,44.825,0.9695431912052758 -48,2018-08-25,-111.325,44.825,0.96953640450366 -48,2018-08-26,-111.325,44.825,0.9695307205436792 -48,2018-08-27,-111.325,44.825,0.9695250544577618 -48,2018-08-28,-111.325,44.825,0.9695193883718446 -48,2018-08-29,-111.325,44.825,0.9695137222859272 -48,2018-08-30,-111.325,44.825,0.9695080562000099 -48,2018-08-31,-111.325,44.825,0.9695019190878527 -48,2018-09-01,-111.325,44.825,0.9694961954377377 -48,2018-09-02,-111.325,44.825,0.9694908715312051 -48,2018-09-03,-111.325,44.825,0.9694855514430568 -48,2018-09-04,-111.325,44.825,0.9694802313549085 -48,2018-09-05,-111.325,44.825,0.9694749112667602 -48,2018-09-06,-111.325,44.825,0.9694695911786119 -48,2018-09-07,-111.325,44.825,0.9694642710904636 -48,2018-09-08,-111.325,44.825,0.969458871035247 -48,2018-09-09,-111.325,44.825,0.9694532413215493 -48,2018-09-10,-111.325,44.825,0.969447921233401 -48,2018-09-11,-111.325,44.825,0.9694424374428261 -48,2018-09-12,-111.325,44.825,0.9694371173546779 -48,2018-09-13,-111.325,44.825,0.9694317972665295 -48,2018-09-14,-111.325,44.825,0.9694264771783813 -48,2018-09-15,-111.325,44.825,0.9694211570902329 -48,2018-09-16,-111.325,44.825,0.9694158370020847 -48,2018-09-17,-111.325,44.825,0.9694105168878404 -48,2018-09-18,-111.325,44.825,0.9694051967996921 -48,2018-09-19,-111.325,44.825,0.9693998767115438 -48,2018-09-20,-111.325,44.825,0.9693945566233955 -48,2018-09-21,-111.325,44.825,0.9693892365352471 -48,2018-09-22,-111.325,44.825,0.9693839164470989 -48,2018-09-23,-111.325,44.825,0.9693785724112806 -48,2018-09-24,-111.325,44.825,0.9693732523231322 -48,2018-09-25,-111.325,44.825,0.969367932234984 -48,2018-09-26,-111.325,44.825,0.9693626121468356 -48,2018-09-27,-111.325,44.825,0.9693572920586874 -48,2018-09-28,-111.325,44.825,0.969351971970539 -48,2018-09-29,-111.325,44.825,0.9693466518823908 -48,2018-09-30,-111.325,44.825,0.9693413317942424 -48,2018-10-01,-111.325,44.825,0.9693360117060942 -48,2018-10-02,-111.325,44.825,0.9693314862481313 -48,2018-10-03,-111.325,44.825,0.9693269607901683 -48,2018-10-04,-111.325,44.825,0.9693224353322054 -48,2018-10-05,-111.325,44.825,0.9693179098742425 -48,2018-10-06,-111.325,44.825,0.9693133844162797 -48,2018-10-07,-111.325,44.825,0.9693088589583168 -48,2018-10-08,-111.325,44.825,0.9693043335003538 -48,2018-10-09,-111.325,44.825,0.9692998080423909 -48,2018-10-10,-111.325,44.825,0.9692952825844281 -48,2018-10-11,-111.325,44.825,0.9692907571264652 -48,2018-10-12,-111.325,44.825,0.9692862316685023 -48,2018-10-13,-111.325,44.825,0.9692817062105393 -48,2018-10-14,-111.325,44.825,0.9692771807525765 -48,2018-10-15,-111.325,44.825,0.9692726552946136 -48,2018-10-16,-111.325,44.825,0.9692681298366507 -48,2018-10-17,-111.325,44.825,0.9692636043786877 -48,2018-10-18,-111.325,44.825,0.9692590789207249 -48,2018-10-19,-111.325,44.825,0.969254553462762 -48,2018-10-20,-111.325,44.825,0.9692500280047991 -48,2018-10-21,-111.325,44.825,0.9692455025468362 -48,2018-10-22,-111.325,44.825,0.9692409770888734 -48,2018-10-23,-111.325,44.825,0.9692364516309104 -48,2018-10-24,-111.325,44.825,0.9692319261729475 -48,2018-10-25,-111.325,44.825,0.9692274007149846 -48,2018-10-26,-111.325,44.825,0.9692228752570218 -48,2018-10-27,-111.325,44.825,0.9692183497990589 -48,2018-10-28,-111.325,44.825,0.9692138243410959 -48,2018-10-29,-111.325,44.825,0.969209298883133 -48,2018-10-30,-111.325,44.825,0.9692047734251702 -48,2018-10-31,-111.325,44.825,0.9692002479672073 -48,2018-11-01,-111.325,44.825,0.9691957225092444 -48,2018-11-02,-111.325,44.825,0.9691916461078606 -48,2018-11-03,-111.325,44.825,0.9691875697064768 -48,2018-11-04,-111.325,44.825,0.969183493305093 -48,2018-11-05,-111.325,44.825,0.9691794169037092 -48,2018-11-06,-111.325,44.825,0.9691753405023256 -48,2018-11-07,-111.325,44.825,0.9691712641009418 -48,2018-11-08,-111.325,44.825,0.969167187699558 -48,2018-11-09,-111.325,44.825,0.9691631112981742 -48,2018-11-10,-111.325,44.825,0.9691590348967905 -48,2018-11-11,-111.325,44.825,0.9691549584954067 -48,2018-11-12,-111.325,44.825,0.9691508820940229 -48,2018-11-13,-111.325,44.825,0.9691468056926391 -48,2018-11-14,-111.325,44.825,0.9691427292912553 -48,2018-11-15,-111.325,44.825,0.9691386528898716 -48,2018-11-16,-111.325,44.825,0.9691345764884878 -48,2018-11-17,-111.325,44.825,0.9691305000871041 -48,2018-11-18,-111.325,44.825,0.9691264236857203 -48,2018-11-19,-111.325,44.825,0.9691223472843365 -48,2018-11-20,-111.325,44.825,0.9691182708829528 -48,2018-11-21,-111.325,44.825,0.969114194481569 -48,2018-11-22,-111.325,44.825,0.9691101180801852 -48,2018-11-23,-111.325,44.825,0.9691060416788014 -48,2018-11-24,-111.325,44.825,0.9691019652774177 -48,2018-11-25,-111.325,44.825,0.9690978888760339 -48,2018-11-26,-111.325,44.825,0.9690938124746501 -48,2018-11-27,-111.325,44.825,0.9690897360732664 -48,2018-11-28,-111.325,44.825,0.9690856596718826 -48,2018-11-29,-111.325,44.825,0.9690815832704989 -48,2018-11-30,-111.325,44.825,0.9690775068691151 -48,2018-12-01,-111.325,44.825,0.9690734304677313 -48,2018-12-02,-111.325,44.825,0.9690698540312149 -48,2018-12-03,-111.325,44.825,0.9690662775946985 -48,2018-12-04,-111.325,44.825,0.9690627011581822 -48,2018-12-05,-111.325,44.825,0.9690591247216658 -48,2018-12-06,-111.325,44.825,0.9690555482851494 -48,2018-12-07,-111.325,44.825,0.9690519718486331 -48,2018-12-08,-111.325,44.825,0.9690483954121167 -48,2018-12-09,-111.325,44.825,0.9690448189756004 -48,2018-12-10,-111.325,44.825,0.969041242539084 -48,2018-12-11,-111.325,44.825,0.9690376661025676 -48,2018-12-12,-111.325,44.825,0.9690340896660512 -48,2018-12-13,-111.325,44.825,0.9690305132295348 -48,2018-12-14,-111.325,44.825,0.9690269367930184 -48,2018-12-15,-111.325,44.825,0.969023360356502 -48,2018-12-16,-111.325,44.825,0.9690197839199858 -48,2018-12-17,-111.325,44.825,0.9690162074834694 -48,2018-12-18,-111.325,44.825,0.969012631046953 -48,2018-12-19,-111.325,44.825,0.9690090546104366 -48,2018-12-20,-111.325,44.825,0.9690054781739202 -48,2018-12-21,-111.325,44.825,0.9690019017374039 -48,2018-12-22,-111.325,44.825,0.9689983253008875 -48,2018-12-23,-111.325,44.825,0.9689947488643711 -48,2018-12-24,-111.325,44.825,0.9689911724278547 -48,2018-12-25,-111.325,44.825,0.9689875959913384 -48,2018-12-26,-111.325,44.825,0.968984019554822 -48,2018-12-27,-111.325,44.825,0.9689804431183057 -48,2018-12-28,-111.325,44.825,0.9689768666817893 -48,2018-12-29,-111.325,44.825,0.9689732902452729 -48,2018-12-30,-111.325,44.825,0.9689697138087565 -48,2018-12-31,-111.325,44.825,0.9689661373722401 -48,2019-01-01,-111.325,44.825,0.9689625609357237 -48,2019-01-02,-111.325,44.825,0.9689586768727338 -48,2019-01-03,-111.325,44.825,0.968954792809744 -48,2019-01-04,-111.325,44.825,0.968950908746754 -48,2019-01-05,-111.325,44.825,0.9689470246837641 -48,2019-01-06,-111.325,44.825,0.9689431406207742 -48,2019-01-07,-111.325,44.825,0.9689392565577843 -48,2019-01-08,-111.325,44.825,0.9689353724947943 -48,2019-01-09,-111.325,44.825,0.9689314884318044 -48,2019-01-10,-111.325,44.825,0.9689276043688145 -48,2019-01-11,-111.325,44.825,0.9689237203058246 -48,2019-01-12,-111.325,44.825,0.9689198362428347 -48,2019-01-13,-111.325,44.825,0.9689159521798448 -48,2019-01-14,-111.325,44.825,0.9689120681168549 -48,2019-01-15,-111.325,44.825,0.968908184053865 -48,2019-01-16,-111.325,44.825,0.968904299990875 -48,2019-01-17,-111.325,44.825,0.9689004159278851 -48,2019-01-18,-111.325,44.825,0.9688965318648952 -48,2019-01-19,-111.325,44.825,0.9688926478019053 -48,2019-01-20,-111.325,44.825,0.9688887637389154 -48,2019-01-21,-111.325,44.825,0.9688848796759255 -48,2019-01-22,-111.325,44.825,0.9688809956129356 -48,2019-01-23,-111.325,44.825,0.9688771115499457 -48,2019-01-24,-111.325,44.825,0.9688732274869558 -48,2019-01-25,-111.325,44.825,0.9688693434239658 -48,2019-01-26,-111.325,44.825,0.9688654593609759 -48,2019-01-27,-111.325,44.825,0.968861575297986 -48,2019-01-28,-111.325,44.825,0.9688576912349961 -48,2019-01-29,-111.325,44.825,0.9688538071720062 -48,2019-01-30,-111.325,44.825,0.9688499231090163 -48,2019-01-31,-111.325,44.825,0.9688460390460264 -48,2019-02-01,-111.325,44.825,0.9688421549830365 -48,2019-02-02,-111.325,44.825,0.9688383733379886 -48,2019-02-03,-111.325,44.825,0.9688345916929407 -48,2019-02-04,-111.325,44.825,0.968830810047893 -48,2019-02-05,-111.325,44.825,0.9688270284028451 -48,2019-02-06,-111.325,44.825,0.9688232467577972 -48,2019-02-07,-111.325,44.825,0.9688194651127494 -48,2019-02-08,-111.325,44.825,0.9688156834677015 -48,2019-02-09,-111.325,44.825,0.9688119018226536 -48,2019-02-10,-111.325,44.825,0.9688081201776059 -48,2019-02-11,-111.325,44.825,0.968804338532558 -48,2019-02-12,-111.325,44.825,0.9688005568875101 -48,2019-02-13,-111.325,44.825,0.9687967752424623 -48,2019-02-14,-111.325,44.825,0.9687929935974144 -48,2019-02-15,-111.325,44.825,0.9687892119523666 -48,2019-02-16,-111.325,44.825,0.9687854303073188 -48,2019-02-17,-111.325,44.825,0.9687816486622709 -48,2019-02-18,-111.325,44.825,0.9687778670172231 -48,2019-02-19,-111.325,44.825,0.9687740853721752 -48,2019-02-20,-111.325,44.825,0.9687703037271274 -48,2019-02-21,-111.325,44.825,0.9687665220820796 -48,2019-02-22,-111.325,44.825,0.9687627404370317 -48,2019-02-23,-111.325,44.825,0.9687589587919838 -48,2019-02-24,-111.325,44.825,0.968755177146936 -48,2019-02-25,-111.325,44.825,0.9687513955018882 -48,2019-02-26,-111.325,44.825,0.9687476138568403 -48,2019-02-27,-111.325,44.825,0.9687438322117925 -48,2019-02-28,-111.325,44.825,0.9687400505667446 -48,2019-03-01,-111.325,44.825,0.9687362689216967 -48,2019-03-02,-111.325,44.825,0.9687323075745675 -48,2019-03-03,-111.325,44.825,0.9687283462274382 -48,2019-03-04,-111.325,44.825,0.9687243848803089 -48,2019-03-05,-111.325,44.825,0.9687204235331796 -48,2019-03-06,-111.325,44.825,0.9687164621860502 -48,2019-03-07,-111.325,44.825,0.9687125008389209 -48,2019-03-08,-111.325,44.825,0.9687085394917916 -48,2019-03-09,-111.325,44.825,0.9687045781446623 -48,2019-03-10,-111.325,44.825,0.968700616797533 -48,2019-03-11,-111.325,44.825,0.9686966554504037 -48,2019-03-12,-111.325,44.825,0.9686926941032744 -48,2019-03-13,-111.325,44.825,0.9686887327561451 -48,2019-03-14,-111.325,44.825,0.9686847714090158 -48,2019-03-15,-111.325,44.825,0.9686808100618864 -48,2019-03-16,-111.325,44.825,0.9686768487147571 -48,2019-03-17,-111.325,44.825,0.9686728873676278 -48,2019-03-18,-111.325,44.825,0.9686689260204985 -48,2019-03-19,-111.325,44.825,0.9686649646733693 -48,2019-03-20,-111.325,44.825,0.9686610033262399 -48,2019-03-21,-111.325,44.825,0.9686570419791106 -48,2019-03-22,-111.325,44.825,0.9686530806319813 -48,2019-03-23,-111.325,44.825,0.968649119284852 -48,2019-03-24,-111.325,44.825,0.9686451579377227 -48,2019-03-25,-111.325,44.825,0.9686411965905933 -48,2019-03-26,-111.325,44.825,0.968637235243464 -48,2019-03-27,-111.325,44.825,0.9686332738963348 -48,2019-03-28,-111.325,44.825,0.9686293125492055 -48,2019-03-29,-111.325,44.825,0.9686253512020762 -48,2019-03-30,-111.325,44.825,0.9686213898549468 -48,2019-03-31,-111.325,44.825,0.9686174285078175 -48,2019-04-01,-111.325,44.825,0.9686134671606882 -48,2019-04-02,-111.325,44.825,0.9686086339307769 -48,2019-04-03,-111.325,44.825,0.9686038007008656 -48,2019-04-04,-111.325,44.825,0.9685989674709542 -48,2019-04-05,-111.325,44.825,0.9685941342410429 -48,2019-04-06,-111.325,44.825,0.9685893010111316 -48,2019-04-07,-111.325,44.825,0.9685844677812202 -48,2019-04-08,-111.325,44.825,0.9685796345513089 -48,2019-04-09,-111.325,44.825,0.9685748013213976 -48,2019-04-10,-111.325,44.825,0.96843056763837 -48,2019-04-11,-111.325,44.825,0.9682240344551905 -48,2019-04-12,-111.325,44.825,0.9682192012252792 -48,2019-04-13,-111.325,44.825,0.9682143679953679 -48,2019-04-14,-111.325,44.825,0.9682095347654565 -48,2019-04-15,-111.325,44.825,0.9682047015355452 -48,2019-04-16,-111.325,44.825,0.9681998683056339 -48,2019-04-17,-111.325,44.825,0.9681950350757225 -48,2019-04-18,-111.325,44.825,0.9681902018458112 -48,2019-04-19,-111.325,44.825,0.9681853686158999 -48,2019-04-20,-111.325,44.825,0.9681805353859885 -48,2019-04-21,-111.325,44.825,0.9681757021560772 -48,2019-04-22,-111.325,44.825,0.9678605472968347 -48,2019-04-23,-111.325,44.825,0.9678614410152463 -48,2019-04-24,-111.325,44.825,0.9681708688683214 -48,2019-04-25,-111.325,44.825,0.9689879035888603 -48,2019-04-26,-111.325,44.825,0.970193353519406 -48,2019-04-27,-111.325,44.825,0.9719197967876209 -48,2019-04-28,-111.325,44.825,0.9737060026736265 -48,2019-04-29,-111.325,44.825,0.9755100142188562 -48,2019-04-30,-111.325,44.825,0.9769292767082948 -48,2019-05-01,-111.325,44.825,0.9778666161471378 -48,2019-05-02,-111.325,44.825,0.9783301730274657 -48,2019-05-03,-111.325,44.825,0.9783953720635645 -48,2019-05-04,-111.325,44.825,0.9780768568312453 -48,2019-05-05,-111.325,44.825,0.977476851878693 -48,2019-05-06,-111.325,44.825,0.976724484259031 -48,2019-05-07,-111.325,44.825,0.9759781863355357 -48,2019-05-08,-111.325,44.825,0.9754172763315833 -48,2019-05-09,-111.325,44.825,0.9750073694527339 -48,2019-05-10,-111.325,44.825,0.9745791341432871 -48,2019-05-11,-111.325,44.825,0.974021197644542 -48,2019-05-12,-111.325,44.825,0.9732898557312987 -48,2019-05-13,-111.325,44.825,0.9725918741377061 -48,2019-05-14,-111.325,44.825,0.9718757216001676 -48,2019-05-15,-111.325,44.825,0.9713775542603998 -48,2019-05-16,-111.325,44.825,0.9716722589648406 -48,2019-05-17,-111.325,44.825,0.9728402061064373 -48,2019-05-18,-111.325,44.825,0.9749584343151192 -48,2019-05-19,-111.325,44.825,0.9775810396143416 -48,2019-05-20,-111.325,44.825,0.98006644185062 -48,2019-05-21,-111.325,44.825,0.9823776239435434 -48,2019-05-22,-111.325,44.825,0.9842314979793629 -48,2019-05-23,-111.325,44.825,0.9847604510936887 -48,2019-05-24,-111.325,44.825,0.9847241549122877 -48,2019-05-25,-111.325,44.825,0.9845134991811992 -48,2019-05-26,-111.325,44.825,0.9843041038296875 -48,2019-05-27,-111.325,44.825,0.9842225427382484 -48,2019-05-28,-111.325,44.825,0.9842868818471652 -48,2019-05-29,-111.325,44.825,0.9843347234060497 -48,2019-05-30,-111.325,44.825,0.9843453123977152 -48,2019-05-31,-111.325,44.825,0.9843670907830123 -48,2019-06-01,-111.325,44.825,0.9844454822585301 -48,2019-06-02,-111.325,44.825,0.9846978356457613 -48,2019-06-03,-111.325,44.825,0.9850660445493996 -48,2019-06-04,-111.325,44.825,0.9854832634385532 -48,2019-06-05,-111.325,44.825,0.9857668973227736 -48,2019-06-06,-111.325,44.825,0.9860577188092772 -48,2019-06-07,-111.325,44.825,0.9861737582355607 -48,2019-06-08,-111.325,44.825,0.9862140624410024 -48,2019-06-09,-111.325,44.825,0.9863702713353705 -48,2019-06-10,-111.325,44.825,0.986206058086217 -48,2019-06-11,-111.325,44.825,0.9858334753198421 -48,2019-06-12,-111.325,44.825,0.9854693022906995 -48,2019-06-13,-111.325,44.825,0.985147539453496 -48,2019-06-14,-111.325,44.825,0.9848650073657677 -48,2019-06-15,-111.325,44.825,0.9846111835467453 -48,2019-06-16,-111.325,44.825,0.9844410709294845 -48,2019-06-17,-111.325,44.825,0.9843005268078009 -48,2019-06-18,-111.325,44.825,0.9841432581431518 -48,2019-06-19,-111.325,44.825,0.9839521692139193 -48,2019-06-20,-111.325,44.825,0.9837632082933836 -48,2019-06-21,-111.325,44.825,0.9834858808655726 -48,2019-06-22,-111.325,44.825,0.9830678863752423 -48,2019-06-23,-111.325,44.825,0.9824779291339869 -48,2019-06-24,-111.325,44.825,0.9817469063652748 -48,2019-06-25,-111.325,44.825,0.9810210438037412 -48,2019-06-26,-111.325,44.825,0.9803255764945915 -48,2019-06-27,-111.325,44.825,0.9796631581101277 -48,2019-06-28,-111.325,44.825,0.9790388283962566 -48,2019-06-29,-111.325,44.825,0.9784452047456971 -48,2019-06-30,-111.325,44.825,0.9778775194545071 -48,2019-07-01,-111.325,44.825,0.977331615718397 -48,2019-07-02,-111.325,44.825,0.9768089997961592 -48,2019-07-03,-111.325,44.825,0.9763073312460917 -48,2019-07-04,-111.325,44.825,0.9758137370564794 -48,2019-07-05,-111.325,44.825,0.9753272504252635 -48,2019-07-06,-111.325,44.825,0.974853539294272 -48,2019-07-07,-111.325,44.825,0.974393901792624 -48,2019-07-08,-111.325,44.825,0.9739415019338544 -48,2019-07-09,-111.325,44.825,0.9734909869829766 -48,2019-07-10,-111.325,44.825,0.9730465149295131 -48,2019-07-11,-111.325,44.825,0.9726094696141264 -48,2019-07-12,-111.325,44.825,0.9721865547395462 -48,2019-07-13,-111.325,44.825,0.971775727120163 -48,2019-07-14,-111.325,44.825,0.9713680865332367 -48,2019-07-15,-111.325,44.825,0.970967748112807 -48,2019-07-16,-111.325,44.825,0.9705729981442383 -48,2019-07-17,-111.325,44.825,0.9701804762624027 -48,2019-07-18,-111.325,44.825,0.9697885355275627 -48,2019-07-19,-111.325,44.825,0.969654047150961 -48,2019-07-20,-111.325,44.825,0.9696483298219858 -48,2019-07-21,-111.325,44.825,0.9696426124930105 -48,2019-07-22,-111.325,44.825,0.9696368951640353 -48,2019-07-23,-111.325,44.825,0.96963117783506 -48,2019-07-24,-111.325,44.825,0.9696254605060848 -48,2019-07-25,-111.325,44.825,0.9696193271825922 -48,2019-07-26,-111.325,44.825,0.969610945949659 -48,2019-07-27,-111.325,44.825,0.9696050834014716 -48,2019-07-28,-111.325,44.825,0.9695991376946558 -48,2019-07-29,-111.325,44.825,0.9695931104114645 -48,2019-07-30,-111.325,44.825,0.9695873265015813 -48,2019-07-31,-111.325,44.825,0.9695797761817285 -48,2019-08-01,-111.325,44.825,0.9695734149247451 -48,2019-08-02,-111.325,44.825,0.969565485377257 -48,2019-08-03,-111.325,44.825,0.969557052433815 -48,2019-08-04,-111.325,44.825,0.969548775305613 -48,2019-08-05,-111.325,44.825,0.9695397884199317 -48,2019-08-06,-111.325,44.825,0.9695313019389313 -48,2019-08-07,-111.325,44.825,0.9695241009237098 -48,2019-08-08,-111.325,44.825,0.9695164104119813 -48,2019-08-09,-111.325,44.825,0.9695085823501682 -48,2019-08-10,-111.325,44.825,0.9695014133098042 -48,2019-08-11,-111.325,44.825,0.9694955933820143 -48,2019-08-12,-111.325,44.825,0.9694897734542244 -48,2019-08-13,-111.325,44.825,0.9694839535264343 -48,2019-08-14,-111.325,44.825,0.9694777885208435 -48,2019-08-15,-111.325,44.825,0.9694718807994009 -48,2019-08-16,-111.325,44.825,0.969461273962016 -48,2019-08-17,-111.325,44.825,0.9694554540342261 -48,2019-08-18,-111.325,44.825,0.9694491270292573 -48,2019-08-19,-111.325,44.825,0.9694423871991331 -48,2019-08-20,-111.325,44.825,0.9694323851931776 -48,2019-08-21,-111.325,44.825,0.9694252987147516 -48,2019-08-22,-111.325,44.825,0.9694182700587459 -48,2019-08-23,-111.325,44.825,0.9694124501309559 -48,2019-08-24,-111.325,44.825,0.969406630203166 -48,2019-08-25,-111.325,44.825,0.9694005306683184 -48,2019-08-26,-111.325,44.825,0.9693927170595298 -48,2019-08-27,-111.325,44.825,0.9693868971317398 -48,2019-08-28,-111.325,44.825,0.9693802423633217 -48,2019-08-29,-111.325,44.825,0.9693730269387418 -48,2019-08-30,-111.325,44.825,0.9693672070109519 -48,2019-08-31,-111.325,44.825,0.9693609558388836 -48,2019-09-01,-111.325,44.825,0.9693487243997632 -48,2019-09-02,-111.325,44.825,0.9693423153683944 -48,2019-09-03,-111.325,44.825,0.9693309975121285 -48,2019-09-04,-111.325,44.825,0.9693230446606699 -48,2019-09-05,-111.325,44.825,0.9693044574765781 -48,2019-09-06,-111.325,44.825,0.9692950399237421 -48,2019-09-07,-111.325,44.825,0.9692895401764675 -48,2019-09-08,-111.325,44.825,0.9692840404291928 -48,2019-09-09,-111.325,44.825,0.9692785406819181 -48,2019-09-10,-111.325,44.825,0.9692730409346434 -48,2019-09-11,-111.325,44.825,0.9692675411873687 -48,2019-09-12,-111.325,44.825,0.9692620414400941 -48,2019-09-13,-111.325,44.825,0.9692565416928194 -48,2019-09-14,-111.325,44.825,0.9692510419455447 -48,2019-09-15,-111.325,44.825,0.96924554219827 -48,2019-09-16,-111.325,44.825,0.9692396583240872 -48,2019-09-17,-111.325,44.825,0.9692340435826998 -48,2019-09-18,-111.325,44.825,0.9692285438354252 -48,2019-09-19,-111.325,44.825,0.9692230440881505 -48,2019-09-20,-111.325,44.825,0.9692175443408758 -48,2019-09-21,-111.325,44.825,0.9692120445936011 -48,2019-09-22,-111.325,44.825,0.9692065448463265 -48,2019-09-23,-111.325,44.825,0.9692010450990518 -48,2019-09-24,-111.325,44.825,0.9691955453517771 -48,2019-09-25,-111.325,44.825,0.9691900456045024 -48,2019-09-26,-111.325,44.825,0.9691845458572278 -48,2019-09-27,-111.325,44.825,0.9691790461099531 -48,2019-09-28,-111.325,44.825,0.9691735463626784 -48,2019-09-29,-111.325,44.825,0.9691680466154037 -48,2019-09-30,-111.325,44.825,0.9691625468681291 -48,2019-10-01,-111.325,44.825,0.9691570471208544 -48,2019-10-02,-111.325,44.825,0.9691527524634909 -48,2019-10-03,-111.325,44.825,0.9691484578061274 -48,2019-10-04,-111.325,44.825,0.9691441631487638 -48,2019-10-05,-111.325,44.825,0.9691398684914003 -48,2019-10-06,-111.325,44.825,0.9691355738340369 -48,2019-10-07,-111.325,44.825,0.9691312791766734 -48,2019-10-08,-111.325,44.825,0.9691269845193099 -48,2019-10-09,-111.325,44.825,0.9691226898619464 -48,2019-10-10,-111.325,44.825,0.9691183952045829 -48,2019-10-11,-111.325,44.825,0.9691141005472194 -48,2019-10-12,-111.325,44.825,0.969109805889856 -48,2019-10-13,-111.325,44.825,0.9691055112324924 -48,2019-10-14,-111.325,44.825,0.9691012165751289 -48,2019-10-15,-111.325,44.825,0.9690969219177654 -48,2019-10-16,-111.325,44.825,0.9690926272604019 -48,2019-10-17,-111.325,44.825,0.9690883326030384 -48,2019-10-18,-111.325,44.825,0.969084037945675 -48,2019-10-19,-111.325,44.825,0.9690797432883115 -48,2019-10-20,-111.325,44.825,0.969075448630948 -48,2019-10-21,-111.325,44.825,0.9690711539735845 -48,2019-10-22,-111.325,44.825,0.9690668593162209 -48,2019-10-23,-111.325,44.825,0.9690625646588574 -48,2019-10-24,-111.325,44.825,0.969058270001494 -48,2019-10-25,-111.325,44.825,0.9690539753441305 -48,2019-10-26,-111.325,44.825,0.969049680686767 -48,2019-10-27,-111.325,44.825,0.9690453860294035 -48,2019-10-28,-111.325,44.825,0.96904109137204 -48,2019-10-29,-111.325,44.825,0.9690367967146765 -48,2019-10-30,-111.325,44.825,0.9690325020573131 -48,2019-10-31,-111.325,44.825,0.9690282073999495 -48,2019-11-01,-111.325,44.825,0.969023912742586 -48,2019-11-02,-111.325,44.825,0.9690196180852225 -48,2019-11-03,-111.325,44.825,0.969015323427859 -48,2019-11-04,-111.325,44.825,0.9690110287704955 -48,2019-11-05,-111.325,44.825,0.9690067341131321 -48,2019-11-06,-111.325,44.825,0.9690024394557686 -48,2019-11-07,-111.325,44.825,0.9689981447984051 -48,2019-11-08,-111.325,44.825,0.9689938501410416 -48,2019-11-09,-111.325,44.825,0.968989555483678 -48,2019-11-10,-111.325,44.825,0.9689852608263145 -48,2019-11-11,-111.325,44.825,0.9689809661689511 -48,2019-11-12,-111.325,44.825,0.9689766715115876 -48,2019-11-13,-111.325,44.825,0.9689723768542241 -48,2019-11-14,-111.325,44.825,0.9689680821968606 -48,2019-11-15,-111.325,44.825,0.9689637875394971 -48,2019-11-16,-111.325,44.825,0.9689594928821336 -48,2019-11-17,-111.325,44.825,0.9689551982247702 -48,2019-11-18,-111.325,44.825,0.9689509035674067 -48,2019-11-19,-111.325,44.825,0.9689466089100431 -48,2019-11-20,-111.325,44.825,0.9689423142526796 -48,2019-11-21,-111.325,44.825,0.9689380195953161 -48,2019-11-22,-111.325,44.825,0.9689337249379526 -48,2019-11-23,-111.325,44.825,0.9689294302805892 -48,2019-11-24,-111.325,44.825,0.9689251356232257 -48,2019-11-25,-111.325,44.825,0.9689208409658622 -48,2019-11-26,-111.325,44.825,0.9689165463084987 -48,2019-11-27,-111.325,44.825,0.9689122516511351 -48,2019-11-28,-111.325,44.825,0.9689079569937716 -48,2019-11-29,-111.325,44.825,0.9689036623364082 -48,2019-11-30,-111.325,44.825,0.9688993676790447 -48,2019-12-01,-111.325,44.825,0.9688950730216812 -48,2019-12-02,-111.325,44.825,0.9688911248795369 -48,2019-12-03,-111.325,44.825,0.9688871767373924 -48,2019-12-04,-111.325,44.825,0.9688832285952481 -48,2019-12-05,-111.325,44.825,0.9688792804531038 -48,2019-12-06,-111.325,44.825,0.9688753323109595 -48,2019-12-07,-111.325,44.825,0.968871384168815 -48,2019-12-08,-111.325,44.825,0.9688674360266707 -48,2019-12-09,-111.325,44.825,0.9688634878845264 -48,2019-12-10,-111.325,44.825,0.968859539742382 -48,2019-12-11,-111.325,44.825,0.9688555916002376 -48,2019-12-12,-111.325,44.825,0.9688516434580933 -48,2019-12-13,-111.325,44.825,0.9688476953159489 -48,2019-12-14,-111.325,44.825,0.9688437471738046 -48,2019-12-15,-111.325,44.825,0.9688397990316603 -48,2019-12-16,-111.325,44.825,0.9688358508895158 -48,2019-12-17,-111.325,44.825,0.9688319027473715 -48,2019-12-18,-111.325,44.825,0.9688279546052272 -48,2019-12-19,-111.325,44.825,0.9688240064630829 -48,2019-12-20,-111.325,44.825,0.9688200583209384 -48,2019-12-21,-111.325,44.825,0.9688161101787941 -48,2019-12-22,-111.325,44.825,0.9688121620366498 -48,2019-12-23,-111.325,44.825,0.9688082138945054 -48,2019-12-24,-111.325,44.825,0.968804265752361 -48,2019-12-25,-111.325,44.825,0.9688003176102167 -48,2019-12-26,-111.325,44.825,0.9687963694680723 -48,2019-12-27,-111.325,44.825,0.968792421325928 -48,2019-12-28,-111.325,44.825,0.9687884731837836 -48,2019-12-29,-111.325,44.825,0.9687845250416393 -48,2019-12-30,-111.325,44.825,0.9687805768994949 -48,2019-12-31,-111.325,44.825,0.9687766287573506 -48,2020-01-01,-111.325,44.825,0.9687726806152062 -146,2018-01-02,-108.17500000000001,43.425000000000004,0.9653961309220185 -146,2018-01-03,-108.17500000000001,43.425000000000004,0.9653949785316646 -146,2018-01-04,-108.17500000000001,43.425000000000004,0.9653938261413106 -146,2018-01-05,-108.17500000000001,43.425000000000004,0.9653926737509567 -146,2018-01-06,-108.17500000000001,43.425000000000004,0.9653915213606027 -146,2018-01-07,-108.17500000000001,43.425000000000004,0.9653903689702488 -146,2018-01-08,-108.17500000000001,43.425000000000004,0.9653892165798948 -146,2018-01-09,-108.17500000000001,43.425000000000004,0.9653880641895409 -146,2018-01-10,-108.17500000000001,43.425000000000004,0.965386911799187 -146,2018-01-11,-108.17500000000001,43.425000000000004,0.965385759408833 -146,2018-01-12,-108.17500000000001,43.425000000000004,0.9653846070184791 -146,2018-01-13,-108.17500000000001,43.425000000000004,0.9653834546281251 -146,2018-01-14,-108.17500000000001,43.425000000000004,0.9653823022377712 -146,2018-01-15,-108.17500000000001,43.425000000000004,0.9653811498474173 -146,2018-01-16,-108.17500000000001,43.425000000000004,0.9653799974570633 -146,2018-01-17,-108.17500000000001,43.425000000000004,0.9653788450667093 -146,2018-01-18,-108.17500000000001,43.425000000000004,0.9653776926763554 -146,2018-01-19,-108.17500000000001,43.425000000000004,0.9653765402860015 -146,2018-01-20,-108.17500000000001,43.425000000000004,0.9653753878956476 -146,2018-01-21,-108.17500000000001,43.425000000000004,0.9653742355052936 -146,2018-01-22,-108.17500000000001,43.425000000000004,0.9653730831149396 -146,2018-01-23,-108.17500000000001,43.425000000000004,0.9653719307245857 -146,2018-01-24,-108.17500000000001,43.425000000000004,0.9653707783342318 -146,2018-01-25,-108.17500000000001,43.425000000000004,0.9653696259438779 -146,2018-01-26,-108.17500000000001,43.425000000000004,0.9653684735535238 -146,2018-01-27,-108.17500000000001,43.425000000000004,0.9653673211631699 -146,2018-01-28,-108.17500000000001,43.425000000000004,0.965366168772816 -146,2018-01-29,-108.17500000000001,43.425000000000004,0.9653650163824621 -146,2018-01-30,-108.17500000000001,43.425000000000004,0.9653638639921082 -146,2018-01-31,-108.17500000000001,43.425000000000004,0.9653627116017541 -146,2018-02-01,-108.17500000000001,43.425000000000004,0.9653615592114002 -146,2018-02-02,-108.17500000000001,43.425000000000004,0.9653603012401979 -146,2018-02-03,-108.17500000000001,43.425000000000004,0.9653590432689956 -146,2018-02-04,-108.17500000000001,43.425000000000004,0.9653577852977933 -146,2018-02-05,-108.17500000000001,43.425000000000004,0.9653565273265908 -146,2018-02-06,-108.17500000000001,43.425000000000004,0.9653552693553885 -146,2018-02-07,-108.17500000000001,43.425000000000004,0.9653540113841862 -146,2018-02-08,-108.17500000000001,43.425000000000004,0.9653527534129839 -146,2018-02-09,-108.17500000000001,43.425000000000004,0.9653514954417814 -146,2018-02-10,-108.17500000000001,43.425000000000004,0.9653502374705791 -146,2018-02-11,-108.17500000000001,43.425000000000004,0.9653489794993768 -146,2018-02-12,-108.17500000000001,43.425000000000004,0.9653477215281745 -146,2018-02-13,-108.17500000000001,43.425000000000004,0.9653464635569721 -146,2018-02-14,-108.17500000000001,43.425000000000004,0.9653452055857698 -146,2018-02-15,-108.17500000000001,43.425000000000004,0.9653439476145674 -146,2018-02-16,-108.17500000000001,43.425000000000004,0.9653426896433651 -146,2018-02-17,-108.17500000000001,43.425000000000004,0.9653414316721628 -146,2018-02-18,-108.17500000000001,43.425000000000004,0.9653401737009604 -146,2018-02-19,-108.17500000000001,43.425000000000004,0.965338915729758 -146,2018-02-20,-108.17500000000001,43.425000000000004,0.9653376577585557 -146,2018-02-21,-108.17500000000001,43.425000000000004,0.9653363997873534 -146,2018-02-22,-108.17500000000001,43.425000000000004,0.965335141816151 -146,2018-02-23,-108.17500000000001,43.425000000000004,0.9653338838449487 -146,2018-02-24,-108.17500000000001,43.425000000000004,0.9653326258737464 -146,2018-02-25,-108.17500000000001,43.425000000000004,0.965331367902544 -146,2018-02-26,-108.17500000000001,43.425000000000004,0.9653301099313416 -146,2018-02-27,-108.17500000000001,43.425000000000004,0.9653288519601393 -146,2018-02-28,-108.17500000000001,43.425000000000004,0.965327593988937 -146,2018-03-01,-108.17500000000001,43.425000000000004,0.9653263360177347 -146,2018-03-02,-108.17500000000001,43.425000000000004,0.9653249562599217 -146,2018-03-03,-108.17500000000001,43.425000000000004,0.9653235765021085 -146,2018-03-04,-108.17500000000001,43.425000000000004,0.9653221967442955 -146,2018-03-05,-108.17500000000001,43.425000000000004,0.9653208169864825 -146,2018-03-06,-108.17500000000001,43.425000000000004,0.9653194372286695 -146,2018-03-07,-108.17500000000001,43.425000000000004,0.9653180574708564 -146,2018-03-08,-108.17500000000001,43.425000000000004,0.9653166777130434 -146,2018-03-09,-108.17500000000001,43.425000000000004,0.9653152979552304 -146,2018-03-10,-108.17500000000001,43.425000000000004,0.9653139181974174 -146,2018-03-11,-108.17500000000001,43.425000000000004,0.9653125384396043 -146,2018-03-12,-108.17500000000001,43.425000000000004,0.9653111586817913 -146,2018-03-13,-108.17500000000001,43.425000000000004,0.9653097789239783 -146,2018-03-14,-108.17500000000001,43.425000000000004,0.9653083991661653 -146,2018-03-15,-108.17500000000001,43.425000000000004,0.9653070194083522 -146,2018-03-16,-108.17500000000001,43.425000000000004,0.9653056396505392 -146,2018-03-17,-108.17500000000001,43.425000000000004,0.9653042598927262 -146,2018-03-18,-108.17500000000001,43.425000000000004,0.9653028801349132 -146,2018-03-19,-108.17500000000001,43.425000000000004,0.9653015003771 -146,2018-03-20,-108.17500000000001,43.425000000000004,0.965300120619287 -146,2018-03-21,-108.17500000000001,43.425000000000004,0.965298740861474 -146,2018-03-22,-108.17500000000001,43.425000000000004,0.965297361103661 -146,2018-03-23,-108.17500000000001,43.425000000000004,0.965295981345848 -146,2018-03-24,-108.17500000000001,43.425000000000004,0.9652946015880349 -146,2018-03-25,-108.17500000000001,43.425000000000004,0.9652932218302219 -146,2018-03-26,-108.17500000000001,43.425000000000004,0.9652918420724089 -146,2018-03-27,-108.17500000000001,43.425000000000004,0.9652904623145959 -146,2018-03-28,-108.17500000000001,43.425000000000004,0.9652890825567828 -146,2018-03-29,-108.17500000000001,43.425000000000004,0.9652877027989698 -146,2018-03-30,-108.17500000000001,43.425000000000004,0.9652863230411568 -146,2018-03-31,-108.17500000000001,43.425000000000004,0.9652849432833438 -146,2018-04-01,-108.17500000000001,43.425000000000004,0.9652835635255307 -146,2018-04-02,-108.17500000000001,43.425000000000004,0.9652819730173638 -146,2018-04-03,-108.17500000000001,43.425000000000004,0.9652803825091969 -146,2018-04-04,-108.17500000000001,43.425000000000004,0.96527879200103 -146,2018-04-05,-108.17500000000001,43.425000000000004,0.9652772014928631 -146,2018-04-06,-108.17500000000001,43.425000000000004,0.9652756109846962 -146,2018-04-07,-108.17500000000001,43.425000000000004,0.9652740204765292 -146,2018-04-08,-108.17500000000001,43.425000000000004,0.9652724299683624 -146,2018-04-09,-108.17500000000001,43.425000000000004,0.9652708394601954 -146,2018-04-10,-108.17500000000001,43.425000000000004,0.9652692489520285 -146,2018-04-11,-108.17500000000001,43.425000000000004,0.9652676584438616 -146,2018-04-12,-108.17500000000001,43.425000000000004,0.9652654608870708 -146,2018-04-13,-108.17500000000001,43.425000000000004,0.9652636586478351 -146,2018-04-14,-108.17500000000001,43.425000000000004,0.9652619842812422 -146,2018-04-15,-108.17500000000001,43.425000000000004,0.9652603937730753 -146,2018-04-16,-108.17500000000001,43.425000000000004,0.965258803141167 -146,2018-04-17,-108.17500000000001,43.425000000000004,0.9652528611310698 -146,2018-04-18,-108.17500000000001,43.425000000000004,0.9652512706229028 -146,2018-04-19,-108.17500000000001,43.425000000000004,0.9652496801147359 -146,2018-04-20,-108.17500000000001,43.425000000000004,0.9652480544543283 -146,2018-04-21,-108.17500000000001,43.425000000000004,0.9652463660838377 -146,2018-04-22,-108.17500000000001,43.425000000000004,0.9652443841101251 -146,2018-04-23,-108.17500000000001,43.425000000000004,0.9652419173398739 -146,2018-04-24,-108.17500000000001,43.425000000000004,0.9652400221588903 -146,2018-04-25,-108.17500000000001,43.425000000000004,0.9652384316507233 -146,2018-04-26,-108.17500000000001,43.425000000000004,0.9652357944559548 -146,2018-04-27,-108.17500000000001,43.425000000000004,0.9652325333685154 -146,2018-04-28,-108.17500000000001,43.425000000000004,0.9652289113360751 -146,2018-04-29,-108.17500000000001,43.425000000000004,0.965225779702056 -146,2018-04-30,-108.17500000000001,43.425000000000004,0.9652210990664838 -146,2018-05-01,-108.17500000000001,43.425000000000004,0.9652195085583168 -146,2018-05-02,-108.17500000000001,43.425000000000004,0.9652178287724889 -146,2018-05-03,-108.17500000000001,43.425000000000004,0.9648104117012034 -146,2018-05-04,-108.17500000000001,43.425000000000004,0.96442166761378 -146,2018-05-05,-108.17500000000001,43.425000000000004,0.9639666979751712 -146,2018-05-06,-108.17500000000001,43.425000000000004,0.9632721149337127 -146,2018-05-07,-108.17500000000001,43.425000000000004,0.9632686823764867 -146,2018-05-08,-108.17500000000001,43.425000000000004,0.9632650686487692 -146,2018-05-09,-108.17500000000001,43.425000000000004,0.9632613536389413 -146,2018-05-10,-108.17500000000001,43.425000000000004,0.9626246333160949 -146,2018-05-11,-108.17500000000001,43.425000000000004,0.9623301330512278 -146,2018-05-12,-108.17500000000001,43.425000000000004,0.9625607821870724 -146,2018-05-13,-108.17500000000001,43.425000000000004,0.9640613014990199 -146,2018-05-14,-108.17500000000001,43.425000000000004,0.9668533456774538 -146,2018-05-15,-108.17500000000001,43.425000000000004,0.9713030578104122 -146,2018-05-16,-108.17500000000001,43.425000000000004,0.9763677002983624 -146,2018-05-17,-108.17500000000001,43.425000000000004,0.9809563825926272 -146,2018-05-18,-108.17500000000001,43.425000000000004,0.9850437274608157 -146,2018-05-19,-108.17500000000001,43.425000000000004,0.9871898903495493 -146,2018-05-20,-108.17500000000001,43.425000000000004,0.9880927149740969 -146,2018-05-21,-108.17500000000001,43.425000000000004,0.9885884826388472 -146,2018-05-22,-108.17500000000001,43.425000000000004,0.9891433698342378 -146,2018-05-23,-108.17500000000001,43.425000000000004,0.9892725268425394 -146,2018-05-24,-108.17500000000001,43.425000000000004,0.9892621216292611 -146,2018-05-25,-108.17500000000001,43.425000000000004,0.989364630075147 -146,2018-05-26,-108.17500000000001,43.425000000000004,0.98982299181531 -146,2018-05-27,-108.17500000000001,43.425000000000004,0.9900988057901084 -146,2018-05-28,-108.17500000000001,43.425000000000004,0.990330851206865 -146,2018-05-29,-108.17500000000001,43.425000000000004,0.9909161592351389 -146,2018-05-30,-108.17500000000001,43.425000000000004,0.9918544122381298 -146,2018-05-31,-108.17500000000001,43.425000000000004,0.9929822934302037 -146,2018-06-01,-108.17500000000001,43.425000000000004,0.9935804818156144 -146,2018-06-02,-108.17500000000001,43.425000000000004,0.9937257637665167 -146,2018-06-03,-108.17500000000001,43.425000000000004,0.9937780908748708 -146,2018-06-04,-108.17500000000001,43.425000000000004,0.9936242308939971 -146,2018-06-05,-108.17500000000001,43.425000000000004,0.9932691705993716 -146,2018-06-06,-108.17500000000001,43.425000000000004,0.9931825005333642 -146,2018-06-07,-108.17500000000001,43.425000000000004,0.9935806783681288 -146,2018-06-08,-108.17500000000001,43.425000000000004,0.9942725117994577 -146,2018-06-09,-108.17500000000001,43.425000000000004,0.9949015178611158 -146,2018-06-10,-108.17500000000001,43.425000000000004,0.9954579051338507 -146,2018-06-11,-108.17500000000001,43.425000000000004,0.996026277668104 -146,2018-06-12,-108.17500000000001,43.425000000000004,0.9963504125248343 -146,2018-06-13,-108.17500000000001,43.425000000000004,0.996502650573316 -146,2018-06-14,-108.17500000000001,43.425000000000004,0.9963616300943067 -146,2018-06-15,-108.17500000000001,43.425000000000004,0.9960499372458911 -146,2018-06-16,-108.17500000000001,43.425000000000004,0.9959257230546479 -146,2018-06-17,-108.17500000000001,43.425000000000004,0.9960241844539331 -146,2018-06-18,-108.17500000000001,43.425000000000004,0.9965702796614656 -146,2018-06-19,-108.17500000000001,43.425000000000004,0.9973408855208863 -146,2018-06-20,-108.17500000000001,43.425000000000004,0.9985718485290711 -146,2018-06-21,-108.17500000000001,43.425000000000004,0.9996335723448432 -146,2018-06-22,-108.17500000000001,43.425000000000004,0.9997719924649681 -146,2018-06-23,-108.17500000000001,43.425000000000004,0.9994820882907005 -146,2018-06-24,-108.17500000000001,43.425000000000004,0.998999939659562 -146,2018-06-25,-108.17500000000001,43.425000000000004,0.9984217318949903 -146,2018-06-26,-108.17500000000001,43.425000000000004,0.9978481708839876 -146,2018-06-27,-108.17500000000001,43.425000000000004,0.9972283269849285 -146,2018-06-28,-108.17500000000001,43.425000000000004,0.9966164942592277 -146,2018-06-29,-108.17500000000001,43.425000000000004,0.9961077175046837 -146,2018-06-30,-108.17500000000001,43.425000000000004,0.9957226387333339 -146,2018-07-01,-108.17500000000001,43.425000000000004,0.9953090880766435 -146,2018-07-02,-108.17500000000001,43.425000000000004,0.9947865535959557 -146,2018-07-03,-108.17500000000001,43.425000000000004,0.9942358924451592 -146,2018-07-04,-108.17500000000001,43.425000000000004,0.9936367737725951 -146,2018-07-05,-108.17500000000001,43.425000000000004,0.9930317880143054 -146,2018-07-06,-108.17500000000001,43.425000000000004,0.9925083271366618 -146,2018-07-07,-108.17500000000001,43.425000000000004,0.9920128537597711 -146,2018-07-08,-108.17500000000001,43.425000000000004,0.9915884966900226 -146,2018-07-09,-108.17500000000001,43.425000000000004,0.9911065059458061 -146,2018-07-10,-108.17500000000001,43.425000000000004,0.9906757762032784 -146,2018-07-11,-108.17500000000001,43.425000000000004,0.9902823784970802 -146,2018-07-12,-108.17500000000001,43.425000000000004,0.9899238941601368 -146,2018-07-13,-108.17500000000001,43.425000000000004,0.9895681685562753 -146,2018-07-14,-108.17500000000001,43.425000000000004,0.9892464190783591 -146,2018-07-15,-108.17500000000001,43.425000000000004,0.9889031821669533 -146,2018-07-16,-108.17500000000001,43.425000000000004,0.9885378099504161 -146,2018-07-17,-108.17500000000001,43.425000000000004,0.9881782719475797 -146,2018-07-18,-108.17500000000001,43.425000000000004,0.9878417112959503 -146,2018-07-19,-108.17500000000001,43.425000000000004,0.9875216342432084 -146,2018-07-20,-108.17500000000001,43.425000000000004,0.987258747859099 -146,2018-07-21,-108.17500000000001,43.425000000000004,0.9869950698855151 -146,2018-07-22,-108.17500000000001,43.425000000000004,0.9867274985783043 -146,2018-07-23,-108.17500000000001,43.425000000000004,0.9864737124901117 -146,2018-07-24,-108.17500000000001,43.425000000000004,0.9862087427187963 -146,2018-07-25,-108.17500000000001,43.425000000000004,0.9859432625056369 -146,2018-07-26,-108.17500000000001,43.425000000000004,0.985691810344953 -146,2018-07-27,-108.17500000000001,43.425000000000004,0.9854779543342382 -146,2018-07-28,-108.17500000000001,43.425000000000004,0.9853091204754088 -146,2018-07-29,-108.17500000000001,43.425000000000004,0.9851813293777861 -146,2018-07-30,-108.17500000000001,43.425000000000004,0.9850007536197433 -146,2018-07-31,-108.17500000000001,43.425000000000004,0.9846732010950953 -146,2018-08-01,-108.17500000000001,43.425000000000004,0.9842159169938427 -146,2018-08-02,-108.17500000000001,43.425000000000004,0.9835908188882061 -146,2018-08-03,-108.17500000000001,43.425000000000004,0.982742157585676 -146,2018-08-04,-108.17500000000001,43.425000000000004,0.9817279287003507 -146,2018-08-05,-108.17500000000001,43.425000000000004,0.9807264448527484 -146,2018-08-06,-108.17500000000001,43.425000000000004,0.9797506169303517 -146,2018-08-07,-108.17500000000001,43.425000000000004,0.9787923045956463 -146,2018-08-08,-108.17500000000001,43.425000000000004,0.9778457019735857 -146,2018-08-09,-108.17500000000001,43.425000000000004,0.9769144120911569 -146,2018-08-10,-108.17500000000001,43.425000000000004,0.976018443574357 -146,2018-08-11,-108.17500000000001,43.425000000000004,0.9751596418715118 -146,2018-08-12,-108.17500000000001,43.425000000000004,0.9743386195004813 -146,2018-08-13,-108.17500000000001,43.425000000000004,0.9735452366421794 -146,2018-08-14,-108.17500000000001,43.425000000000004,0.9727744428691889 -146,2018-08-15,-108.17500000000001,43.425000000000004,0.9720258176177833 -146,2018-08-16,-108.17500000000001,43.425000000000004,0.9712950977564864 -146,2018-08-17,-108.17500000000001,43.425000000000004,0.9705840263292121 -146,2018-08-18,-108.17500000000001,43.425000000000004,0.9698970367498984 -146,2018-08-19,-108.17500000000001,43.425000000000004,0.9693375429905027 -146,2018-08-20,-108.17500000000001,43.425000000000004,0.9693354768366801 -146,2018-08-21,-108.17500000000001,43.425000000000004,0.9693335954037896 -146,2018-08-22,-108.17500000000001,43.425000000000004,0.9693317290939727 -146,2018-08-23,-108.17500000000001,43.425000000000004,0.9693277074168776 -146,2018-08-24,-108.17500000000001,43.425000000000004,0.9693183079089377 -146,2018-08-25,-108.17500000000001,43.425000000000004,0.9693107257149428 -146,2018-08-26,-108.17500000000001,43.425000000000004,0.9693045494100638 -146,2018-08-27,-108.17500000000001,43.425000000000004,0.9692926715902618 -146,2018-08-28,-108.17500000000001,43.425000000000004,0.9692878153218 -146,2018-08-29,-108.17500000000001,43.425000000000004,0.9692839007730577 -146,2018-08-30,-108.17500000000001,43.425000000000004,0.9692800383871029 -146,2018-08-31,-108.17500000000001,43.425000000000004,0.9692748827971528 -146,2018-09-01,-108.17500000000001,43.425000000000004,0.969269344531307 -146,2018-09-02,-108.17500000000001,43.425000000000004,0.9692637999983503 -146,2018-09-03,-108.17500000000001,43.425000000000004,0.9692567590321884 -146,2018-09-04,-108.17500000000001,43.425000000000004,0.9692503732343788 -146,2018-09-05,-108.17500000000001,43.425000000000004,0.969245562102564 -146,2018-09-06,-108.17500000000001,43.425000000000004,0.9692412904833646 -146,2018-09-07,-108.17500000000001,43.425000000000004,0.9692363306055 -146,2018-09-08,-108.17500000000001,43.425000000000004,0.9692308773342186 -146,2018-09-09,-108.17500000000001,43.425000000000004,0.9692285616150174 -146,2018-09-10,-108.17500000000001,43.425000000000004,0.9692218705268991 -146,2018-09-11,-108.17500000000001,43.425000000000004,0.9692135258829739 -146,2018-09-12,-108.17500000000001,43.425000000000004,0.9692061692453977 -146,2018-09-13,-108.17500000000001,43.425000000000004,0.9691960570241135 -146,2018-09-14,-108.17500000000001,43.425000000000004,0.969188875855805 -146,2018-09-15,-108.17500000000001,43.425000000000004,0.9691843951159684 -146,2018-09-16,-108.17500000000001,43.425000000000004,0.9691753688504311 -146,2018-09-17,-108.17500000000001,43.425000000000004,0.9691636398610401 -146,2018-09-18,-108.17500000000001,43.425000000000004,0.9691576731791132 -146,2018-09-19,-108.17500000000001,43.425000000000004,0.969150245910092 -146,2018-09-20,-108.17500000000001,43.425000000000004,0.9691443565641515 -146,2018-09-21,-108.17500000000001,43.425000000000004,0.9691381760581019 -146,2018-09-22,-108.17500000000001,43.425000000000004,0.9691359076939217 -146,2018-09-23,-108.17500000000001,43.425000000000004,0.9691303074822992 -146,2018-09-24,-108.17500000000001,43.425000000000004,0.9691260807530407 -146,2018-09-25,-108.17500000000001,43.425000000000004,0.9691230316905007 -146,2018-09-26,-108.17500000000001,43.425000000000004,0.9691212140169891 -146,2018-09-27,-108.17500000000001,43.425000000000004,0.9691193963434777 -146,2018-09-28,-108.17500000000001,43.425000000000004,0.9691175786699661 -146,2018-09-29,-108.17500000000001,43.425000000000004,0.9691157609964545 -146,2018-09-30,-108.17500000000001,43.425000000000004,0.9691139433229429 -146,2018-10-01,-108.17500000000001,43.425000000000004,0.9691121256494313 -146,2018-10-02,-108.17500000000001,43.425000000000004,0.9691106406701236 -146,2018-10-03,-108.17500000000001,43.425000000000004,0.9691068617899337 -146,2018-10-04,-108.17500000000001,43.425000000000004,0.9691049652645801 -146,2018-10-05,-108.17500000000001,43.425000000000004,0.9691034802852725 -146,2018-10-06,-108.17500000000001,43.425000000000004,0.9691019953059649 -146,2018-10-07,-108.17500000000001,43.425000000000004,0.9691005103266571 -146,2018-10-08,-108.17500000000001,43.425000000000004,0.9690990253473495 -146,2018-10-09,-108.17500000000001,43.425000000000004,0.9690975403680419 -146,2018-10-10,-108.17500000000001,43.425000000000004,0.9690960553887342 -146,2018-10-11,-108.17500000000001,43.425000000000004,0.9690945704094266 -146,2018-10-12,-108.17500000000001,43.425000000000004,0.969093085430119 -146,2018-10-13,-108.17500000000001,43.425000000000004,0.9690916004508112 -146,2018-10-14,-108.17500000000001,43.425000000000004,0.9690901154715036 -146,2018-10-15,-108.17500000000001,43.425000000000004,0.969088630492196 -146,2018-10-16,-108.17500000000001,43.425000000000004,0.9690871455128883 -146,2018-10-17,-108.17500000000001,43.425000000000004,0.9690856605335807 -146,2018-10-18,-108.17500000000001,43.425000000000004,0.969084175554273 -146,2018-10-19,-108.17500000000001,43.425000000000004,0.9690826905749653 -146,2018-10-20,-108.17500000000001,43.425000000000004,0.9690812055956577 -146,2018-10-21,-108.17500000000001,43.425000000000004,0.9690797206163501 -146,2018-10-22,-108.17500000000001,43.425000000000004,0.9690782356370424 -146,2018-10-23,-108.17500000000001,43.425000000000004,0.9690767506577347 -146,2018-10-24,-108.17500000000001,43.425000000000004,0.9690752656784271 -146,2018-10-25,-108.17500000000001,43.425000000000004,0.9690737806991194 -146,2018-10-26,-108.17500000000001,43.425000000000004,0.9690722957198118 -146,2018-10-27,-108.17500000000001,43.425000000000004,0.9690708107405042 -146,2018-10-28,-108.17500000000001,43.425000000000004,0.9690693257611965 -146,2018-10-29,-108.17500000000001,43.425000000000004,0.9690678407818888 -146,2018-10-30,-108.17500000000001,43.425000000000004,0.9690663558025812 -146,2018-10-31,-108.17500000000001,43.425000000000004,0.9690648708232735 -146,2018-11-01,-108.17500000000001,43.425000000000004,0.9690633858439659 -146,2018-11-02,-108.17500000000001,43.425000000000004,0.9690621035349276 -146,2018-11-03,-108.17500000000001,43.425000000000004,0.9690608212258893 -146,2018-11-04,-108.17500000000001,43.425000000000004,0.969059538916851 -146,2018-11-05,-108.17500000000001,43.425000000000004,0.9690582566078129 -146,2018-11-06,-108.17500000000001,43.425000000000004,0.9690569742987746 -146,2018-11-07,-108.17500000000001,43.425000000000004,0.9690556919897363 -146,2018-11-08,-108.17500000000001,43.425000000000004,0.969054409680698 -146,2018-11-09,-108.17500000000001,43.425000000000004,0.9690531273716597 -146,2018-11-10,-108.17500000000001,43.425000000000004,0.9690518450626214 -146,2018-11-11,-108.17500000000001,43.425000000000004,0.9690505627535833 -146,2018-11-12,-108.17500000000001,43.425000000000004,0.969049280444545 -146,2018-11-13,-108.17500000000001,43.425000000000004,0.9690479981355067 -146,2018-11-14,-108.17500000000001,43.425000000000004,0.9690467158264684 -146,2018-11-15,-108.17500000000001,43.425000000000004,0.9690454335174301 -146,2018-11-16,-108.17500000000001,43.425000000000004,0.9690441512083918 -146,2018-11-17,-108.17500000000001,43.425000000000004,0.9690428688993536 -146,2018-11-18,-108.17500000000001,43.425000000000004,0.9690415865903154 -146,2018-11-19,-108.17500000000001,43.425000000000004,0.9690403042812771 -146,2018-11-20,-108.17500000000001,43.425000000000004,0.9690390219722388 -146,2018-11-21,-108.17500000000001,43.425000000000004,0.9690377396632005 -146,2018-11-22,-108.17500000000001,43.425000000000004,0.9690364573541622 -146,2018-11-23,-108.17500000000001,43.425000000000004,0.969035175045124 -146,2018-11-24,-108.17500000000001,43.425000000000004,0.9690338927360858 -146,2018-11-25,-108.17500000000001,43.425000000000004,0.9690326104270475 -146,2018-11-26,-108.17500000000001,43.425000000000004,0.9690313281180092 -146,2018-11-27,-108.17500000000001,43.425000000000004,0.9690300458089709 -146,2018-11-28,-108.17500000000001,43.425000000000004,0.9690287634999326 -146,2018-11-29,-108.17500000000001,43.425000000000004,0.9690274811908944 -146,2018-11-30,-108.17500000000001,43.425000000000004,0.9690261988818561 -146,2018-12-01,-108.17500000000001,43.425000000000004,0.9690249165728179 -146,2018-12-02,-108.17500000000001,43.425000000000004,0.9690238291287879 -146,2018-12-03,-108.17500000000001,43.425000000000004,0.969022741684758 -146,2018-12-04,-108.17500000000001,43.425000000000004,0.9690216542407281 -146,2018-12-05,-108.17500000000001,43.425000000000004,0.9690205667966981 -146,2018-12-06,-108.17500000000001,43.425000000000004,0.9690194793526682 -146,2018-12-07,-108.17500000000001,43.425000000000004,0.9690183919086383 -146,2018-12-08,-108.17500000000001,43.425000000000004,0.9690173044646084 -146,2018-12-09,-108.17500000000001,43.425000000000004,0.9690162170205785 -146,2018-12-10,-108.17500000000001,43.425000000000004,0.9690151295765486 -146,2018-12-11,-108.17500000000001,43.425000000000004,0.9690140421325186 -146,2018-12-12,-108.17500000000001,43.425000000000004,0.9690129546884887 -146,2018-12-13,-108.17500000000001,43.425000000000004,0.9690118672444588 -146,2018-12-14,-108.17500000000001,43.425000000000004,0.9690107798004288 -146,2018-12-15,-108.17500000000001,43.425000000000004,0.9690096923563989 -146,2018-12-16,-108.17500000000001,43.425000000000004,0.969008604912369 -146,2018-12-17,-108.17500000000001,43.425000000000004,0.969007517468339 -146,2018-12-18,-108.17500000000001,43.425000000000004,0.9690064300243091 -146,2018-12-19,-108.17500000000001,43.425000000000004,0.9690053425802791 -146,2018-12-20,-108.17500000000001,43.425000000000004,0.9690042551362492 -146,2018-12-21,-108.17500000000001,43.425000000000004,0.9690031676922194 -146,2018-12-22,-108.17500000000001,43.425000000000004,0.9690020802481895 -146,2018-12-23,-108.17500000000001,43.425000000000004,0.9690009928041595 -146,2018-12-24,-108.17500000000001,43.425000000000004,0.9689999053601296 -146,2018-12-25,-108.17500000000001,43.425000000000004,0.9689988179160997 -146,2018-12-26,-108.17500000000001,43.425000000000004,0.9689977304720697 -146,2018-12-27,-108.17500000000001,43.425000000000004,0.9689966430280398 -146,2018-12-28,-108.17500000000001,43.425000000000004,0.9689955555840098 -146,2018-12-29,-108.17500000000001,43.425000000000004,0.9689944681399799 -146,2018-12-30,-108.17500000000001,43.425000000000004,0.96899338069595 -146,2018-12-31,-108.17500000000001,43.425000000000004,0.96899229325192 -146,2019-01-01,-108.17500000000001,43.425000000000004,0.9689912058078901 -146,2019-01-02,-108.17500000000001,43.425000000000004,0.968990102177767 -146,2019-01-03,-108.17500000000001,43.425000000000004,0.9689889985476439 -146,2019-01-04,-108.17500000000001,43.425000000000004,0.9689878949175208 -146,2019-01-05,-108.17500000000001,43.425000000000004,0.9689867912873977 -146,2019-01-06,-108.17500000000001,43.425000000000004,0.9689856876572746 -146,2019-01-07,-108.17500000000001,43.425000000000004,0.9689845840271515 -146,2019-01-08,-108.17500000000001,43.425000000000004,0.9689834803970283 -146,2019-01-09,-108.17500000000001,43.425000000000004,0.9689823767669052 -146,2019-01-10,-108.17500000000001,43.425000000000004,0.9689812731367821 -146,2019-01-11,-108.17500000000001,43.425000000000004,0.968980169506659 -146,2019-01-12,-108.17500000000001,43.425000000000004,0.9689790658765358 -146,2019-01-13,-108.17500000000001,43.425000000000004,0.9689779622464127 -146,2019-01-14,-108.17500000000001,43.425000000000004,0.9689768586162897 -146,2019-01-15,-108.17500000000001,43.425000000000004,0.9689757549861665 -146,2019-01-16,-108.17500000000001,43.425000000000004,0.9689746513560434 -146,2019-01-17,-108.17500000000001,43.425000000000004,0.9689735477259203 -146,2019-01-18,-108.17500000000001,43.425000000000004,0.9689724440957972 -146,2019-01-19,-108.17500000000001,43.425000000000004,0.968971340465674 -146,2019-01-20,-108.17500000000001,43.425000000000004,0.968970236835551 -146,2019-01-21,-108.17500000000001,43.425000000000004,0.9689691332054278 -146,2019-01-22,-108.17500000000001,43.425000000000004,0.9689680295753047 -146,2019-01-23,-108.17500000000001,43.425000000000004,0.9689669259451816 -146,2019-01-24,-108.17500000000001,43.425000000000004,0.9689658223150585 -146,2019-01-25,-108.17500000000001,43.425000000000004,0.9689647186849354 -146,2019-01-26,-108.17500000000001,43.425000000000004,0.9689636150548122 -146,2019-01-27,-108.17500000000001,43.425000000000004,0.9689625114246891 -146,2019-01-28,-108.17500000000001,43.425000000000004,0.968961407794566 -146,2019-01-29,-108.17500000000001,43.425000000000004,0.9689603041644429 -146,2019-01-30,-108.17500000000001,43.425000000000004,0.9689592005343197 -146,2019-01-31,-108.17500000000001,43.425000000000004,0.9689580969041967 -146,2019-02-01,-108.17500000000001,43.425000000000004,0.9689569932740736 -146,2019-02-02,-108.17500000000001,43.425000000000004,0.9689557353028712 -146,2019-02-03,-108.17500000000001,43.425000000000004,0.9689544773316688 -146,2019-02-04,-108.17500000000001,43.425000000000004,0.9689532193604665 -146,2019-02-05,-108.17500000000001,43.425000000000004,0.9689519613892642 -146,2019-02-06,-108.17500000000001,43.425000000000004,0.9689507034180618 -146,2019-02-07,-108.17500000000001,43.425000000000004,0.9689494454468595 -146,2019-02-08,-108.17500000000001,43.425000000000004,0.9689481874756571 -146,2019-02-09,-108.17500000000001,43.425000000000004,0.9689469295044548 -146,2019-02-10,-108.17500000000001,43.425000000000004,0.9689456715332524 -146,2019-02-11,-108.17500000000001,43.425000000000004,0.9689444135620501 -146,2019-02-12,-108.17500000000001,43.425000000000004,0.9689431555908478 -146,2019-02-13,-108.17500000000001,43.425000000000004,0.9689418976196454 -146,2019-02-14,-108.17500000000001,43.425000000000004,0.9689406396484431 -146,2019-02-15,-108.17500000000001,43.425000000000004,0.9689393816772407 -146,2019-02-16,-108.17500000000001,43.425000000000004,0.9689381237060384 -146,2019-02-17,-108.17500000000001,43.425000000000004,0.9689368657348361 -146,2019-02-18,-108.17500000000001,43.425000000000004,0.9689356077636337 -146,2019-02-19,-108.17500000000001,43.425000000000004,0.9689343497924313 -146,2019-02-20,-108.17500000000001,43.425000000000004,0.968933091821229 -146,2019-02-21,-108.17500000000001,43.425000000000004,0.9689318338500267 -146,2019-02-22,-108.17500000000001,43.425000000000004,0.9689305758788244 -146,2019-02-23,-108.17500000000001,43.425000000000004,0.968929317907622 -146,2019-02-24,-108.17500000000001,43.425000000000004,0.9689280599364196 -146,2019-02-25,-108.17500000000001,43.425000000000004,0.9689268019652173 -146,2019-02-26,-108.17500000000001,43.425000000000004,0.9689199058181843 -146,2019-02-27,-108.17500000000001,43.425000000000004,0.9688844629199068 -146,2019-02-28,-108.17500000000001,43.425000000000004,0.9688550392315987 -146,2019-03-01,-108.17500000000001,43.425000000000004,0.9688524153037505 -146,2019-03-02,-108.17500000000001,43.425000000000004,0.9688510924057387 -146,2019-03-03,-108.17500000000001,43.425000000000004,0.9688497695077269 -146,2019-03-04,-108.17500000000001,43.425000000000004,0.9688484466097151 -146,2019-03-05,-108.17500000000001,43.425000000000004,0.9688441579014626 -146,2019-03-06,-108.17500000000001,43.425000000000004,0.9688055745257536 -146,2019-03-07,-108.17500000000001,43.425000000000004,0.9687357245182275 -146,2019-03-08,-108.17500000000001,43.425000000000004,0.9686389998851803 -146,2019-03-09,-108.17500000000001,43.425000000000004,0.968537108044073 -146,2019-03-10,-108.17500000000001,43.425000000000004,0.9684447422568615 -146,2019-03-11,-108.17500000000001,43.425000000000004,0.9683550684966846 -146,2019-03-12,-108.17500000000001,43.425000000000004,0.9682500691363125 -146,2019-03-13,-108.17500000000001,43.425000000000004,0.9681143331342481 -146,2019-03-14,-108.17500000000001,43.425000000000004,0.9679813415983087 -146,2019-03-15,-108.17500000000001,43.425000000000004,0.9678456328051217 -146,2019-03-16,-108.17500000000001,43.425000000000004,0.9677078887690225 -146,2019-03-17,-108.17500000000001,43.425000000000004,0.9675570782475486 -146,2019-03-18,-108.17500000000001,43.425000000000004,0.9673752275364198 -146,2019-03-19,-108.17500000000001,43.425000000000004,0.9671959288111526 -146,2019-03-20,-108.17500000000001,43.425000000000004,0.9671640837851603 -146,2019-03-21,-108.17500000000001,43.425000000000004,0.9671626807338723 -146,2019-03-22,-108.17500000000001,43.425000000000004,0.9671613264620895 -146,2019-03-23,-108.17500000000001,43.425000000000004,0.9671599913754076 -146,2019-03-24,-108.17500000000001,43.425000000000004,0.9671586684773958 -146,2019-03-25,-108.17500000000001,43.425000000000004,0.967157345579384 -146,2019-03-26,-108.17500000000001,43.425000000000004,0.9671560226813722 -146,2019-03-27,-108.17500000000001,43.425000000000004,0.9671544830028413 -146,2019-03-28,-108.17500000000001,43.425000000000004,0.9671515046535326 -146,2019-03-29,-108.17500000000001,43.425000000000004,0.967149393232255 -146,2019-03-30,-108.17500000000001,43.425000000000004,0.9671480703342432 -146,2019-03-31,-108.17500000000001,43.425000000000004,0.9671467474362314 -146,2019-04-01,-108.17500000000001,43.425000000000004,0.9671454245382196 -146,2019-04-02,-108.17500000000001,43.425000000000004,0.9671438340300528 -146,2019-04-03,-108.17500000000001,43.425000000000004,0.9671422435218858 -146,2019-04-04,-108.17500000000001,43.425000000000004,0.9671406530137189 -146,2019-04-05,-108.17500000000001,43.425000000000004,0.9671390450403756 -146,2019-04-06,-108.17500000000001,43.425000000000004,0.9671361190193434 -146,2019-04-07,-108.17500000000001,43.425000000000004,0.9671342540762818 -146,2019-04-08,-108.17500000000001,43.425000000000004,0.9671325556967025 -146,2019-04-09,-108.17500000000001,43.425000000000004,0.9671299964668648 -146,2019-04-10,-108.17500000000001,43.425000000000004,0.9671284059586979 -146,2019-04-11,-108.17500000000001,43.425000000000004,0.9671268154505309 -146,2019-04-12,-108.17500000000001,43.425000000000004,0.9671252249423641 -146,2019-04-13,-108.17500000000001,43.425000000000004,0.9667069297965829 -146,2019-04-14,-108.17500000000001,43.425000000000004,0.9659991095489849 -146,2019-04-15,-108.17500000000001,43.425000000000004,0.9658378858300871 -146,2019-04-16,-108.17500000000001,43.425000000000004,0.9658362953219202 -146,2019-04-17,-108.17500000000001,43.425000000000004,0.9658347048137532 -146,2019-04-18,-108.17500000000001,43.425000000000004,0.9658331143055864 -146,2019-04-19,-108.17500000000001,43.425000000000004,0.9658314995377962 -146,2019-04-20,-108.17500000000001,43.425000000000004,0.9658269585309723 -146,2019-04-21,-108.17500000000001,43.425000000000004,0.9658222985410424 -146,2019-04-22,-108.17500000000001,43.425000000000004,0.9658207080328756 -146,2019-04-23,-108.17500000000001,43.425000000000004,0.9658191175247086 -146,2019-04-24,-108.17500000000001,43.425000000000004,0.9658168051825377 -146,2019-04-25,-108.17500000000001,43.425000000000004,0.9658149791597006 -146,2019-04-26,-108.17500000000001,43.425000000000004,0.9658133750191981 -146,2019-04-27,-108.17500000000001,43.425000000000004,0.9658117845110311 -146,2019-04-28,-108.17500000000001,43.425000000000004,0.9658101049817799 -146,2019-04-29,-108.17500000000001,43.425000000000004,0.9658083535418636 -146,2019-04-30,-108.17500000000001,43.425000000000004,0.9658067630336966 -146,2019-05-01,-108.17500000000001,43.425000000000004,0.9658051725255297 -146,2019-05-02,-108.17500000000001,43.425000000000004,0.9658035820173628 -146,2019-05-03,-108.17500000000001,43.425000000000004,0.965801204442612 -146,2019-05-04,-108.17500000000001,43.425000000000004,0.9657993280383111 -146,2019-05-05,-108.17500000000001,43.425000000000004,0.9657960586377422 -146,2019-05-06,-108.17500000000001,43.425000000000004,0.9657944188536344 -146,2019-05-07,-108.17500000000001,43.425000000000004,0.9657927320649092 -146,2019-05-08,-108.17500000000001,43.425000000000004,0.9657911415567423 -146,2019-05-09,-108.17500000000001,43.425000000000004,0.9657895510485754 -146,2019-05-10,-108.17500000000001,43.425000000000004,0.9657879605404085 -146,2019-05-11,-108.17500000000001,43.425000000000004,0.9654902799206412 -146,2019-05-12,-108.17500000000001,43.425000000000004,0.9647696737767044 -146,2019-05-13,-108.17500000000001,43.425000000000004,0.9643095654560924 -146,2019-05-14,-108.17500000000001,43.425000000000004,0.9643048668206915 -146,2019-05-15,-108.17500000000001,43.425000000000004,0.9643011096636089 -146,2019-05-16,-108.17500000000001,43.425000000000004,0.9642966970774591 -146,2019-05-17,-108.17500000000001,43.425000000000004,0.9642924350702072 -146,2019-05-18,-108.17500000000001,43.425000000000004,0.9638492824700566 -146,2019-05-19,-108.17500000000001,43.425000000000004,0.9634683197251851 -146,2019-05-20,-108.17500000000001,43.425000000000004,0.963411716847028 -146,2019-05-21,-108.17500000000001,43.425000000000004,0.9634860577700824 -146,2019-05-22,-108.17500000000001,43.425000000000004,0.9635366805454932 -146,2019-05-23,-108.17500000000001,43.425000000000004,0.9637854474786652 -146,2019-05-24,-108.17500000000001,43.425000000000004,0.9641650197645149 -146,2019-05-25,-108.17500000000001,43.425000000000004,0.964765616257484 -146,2019-05-26,-108.17500000000001,43.425000000000004,0.965413873157263 -146,2019-05-27,-108.17500000000001,43.425000000000004,0.9660376767456856 -146,2019-05-28,-108.17500000000001,43.425000000000004,0.9668675339026008 -146,2019-05-29,-108.17500000000001,43.425000000000004,0.9686659168630058 -146,2019-05-30,-108.17500000000001,43.425000000000004,0.9719334011754528 -146,2019-05-31,-108.17500000000001,43.425000000000004,0.9767666390114101 -146,2019-06-01,-108.17500000000001,43.425000000000004,0.9817016294962108 -146,2019-06-02,-108.17500000000001,43.425000000000004,0.9857805057833545 -146,2019-06-03,-108.17500000000001,43.425000000000004,0.9873801466805937 -146,2019-06-04,-108.17500000000001,43.425000000000004,0.9878431648657613 -146,2019-06-05,-108.17500000000001,43.425000000000004,0.9880366611103607 -146,2019-06-06,-108.17500000000001,43.425000000000004,0.9881960200238068 -146,2019-06-07,-108.17500000000001,43.425000000000004,0.9883968586485412 -146,2019-06-08,-108.17500000000001,43.425000000000004,0.9886479993807606 -146,2019-06-09,-108.17500000000001,43.425000000000004,0.9890292445106043 -146,2019-06-10,-108.17500000000001,43.425000000000004,0.9893661010161129 -146,2019-06-11,-108.17500000000001,43.425000000000004,0.9893884503820201 -146,2019-06-12,-108.17500000000001,43.425000000000004,0.9890012439530865 -146,2019-06-13,-108.17500000000001,43.425000000000004,0.9885269535022843 -146,2019-06-14,-108.17500000000001,43.425000000000004,0.9882491975033824 -146,2019-06-15,-108.17500000000001,43.425000000000004,0.9882792523501844 -146,2019-06-16,-108.17500000000001,43.425000000000004,0.9885724909275532 -146,2019-06-17,-108.17500000000001,43.425000000000004,0.9889338426779826 -146,2019-06-18,-108.17500000000001,43.425000000000004,0.9893151448570354 -146,2019-06-19,-108.17500000000001,43.425000000000004,0.9897987436806909 -146,2019-06-20,-108.17500000000001,43.425000000000004,0.9902498830112374 -146,2019-06-21,-108.17500000000001,43.425000000000004,0.9904848420764112 -146,2019-06-22,-108.17500000000001,43.425000000000004,0.9904677469220371 -146,2019-06-23,-108.17500000000001,43.425000000000004,0.9901961442166742 -146,2019-06-24,-108.17500000000001,43.425000000000004,0.9897558970623541 -146,2019-06-25,-108.17500000000001,43.425000000000004,0.9892685914466558 -146,2019-06-26,-108.17500000000001,43.425000000000004,0.9888707042464286 -146,2019-06-27,-108.17500000000001,43.425000000000004,0.9886421611998132 -146,2019-06-28,-108.17500000000001,43.425000000000004,0.9886145135500939 -146,2019-06-29,-108.17500000000001,43.425000000000004,0.988766776665954 -146,2019-06-30,-108.17500000000001,43.425000000000004,0.9889808896380494 -146,2019-07-01,-108.17500000000001,43.425000000000004,0.9892645586825959 -146,2019-07-02,-108.17500000000001,43.425000000000004,0.9894940559881731 -146,2019-07-03,-108.17500000000001,43.425000000000004,0.989593913840372 -146,2019-07-04,-108.17500000000001,43.425000000000004,0.9896034445240645 -146,2019-07-05,-108.17500000000001,43.425000000000004,0.9896227855187357 -146,2019-07-06,-108.17500000000001,43.425000000000004,0.9896772453445866 -146,2019-07-07,-108.17500000000001,43.425000000000004,0.9897526654660826 -146,2019-07-08,-108.17500000000001,43.425000000000004,0.989576382766955 -146,2019-07-09,-108.17500000000001,43.425000000000004,0.9892451032751527 -146,2019-07-10,-108.17500000000001,43.425000000000004,0.9889035147163877 -146,2019-07-11,-108.17500000000001,43.425000000000004,0.9886072209273152 -146,2019-07-12,-108.17500000000001,43.425000000000004,0.9882817566611075 -146,2019-07-13,-108.17500000000001,43.425000000000004,0.9879204631662776 -146,2019-07-14,-108.17500000000001,43.425000000000004,0.9875756139763685 -146,2019-07-15,-108.17500000000001,43.425000000000004,0.9872523782011651 -146,2019-07-16,-108.17500000000001,43.425000000000004,0.9869251829336324 -146,2019-07-17,-108.17500000000001,43.425000000000004,0.9866584272970575 -146,2019-07-18,-108.17500000000001,43.425000000000004,0.9864755597437388 -146,2019-07-19,-108.17500000000001,43.425000000000004,0.9862667909152071 -146,2019-07-20,-108.17500000000001,43.425000000000004,0.9860390211797432 -146,2019-07-21,-108.17500000000001,43.425000000000004,0.9858163334507467 -146,2019-07-22,-108.17500000000001,43.425000000000004,0.985580754034802 -146,2019-07-23,-108.17500000000001,43.425000000000004,0.9853636524587426 -146,2019-07-24,-108.17500000000001,43.425000000000004,0.9851567912873338 -146,2019-07-25,-108.17500000000001,43.425000000000004,0.9848762524014407 -146,2019-07-26,-108.17500000000001,43.425000000000004,0.9843567791763441 -146,2019-07-27,-108.17500000000001,43.425000000000004,0.9836284292812079 -146,2019-07-28,-108.17500000000001,43.425000000000004,0.9827763517259779 -146,2019-07-29,-108.17500000000001,43.425000000000004,0.9817804901345755 -146,2019-07-30,-108.17500000000001,43.425000000000004,0.9807539932545181 -146,2019-07-31,-108.17500000000001,43.425000000000004,0.9797403178889043 -146,2019-08-01,-108.17500000000001,43.425000000000004,0.9787561708751661 -146,2019-08-02,-108.17500000000001,43.425000000000004,0.977798402554565 -146,2019-08-03,-108.17500000000001,43.425000000000004,0.9768679466241045 -146,2019-08-04,-108.17500000000001,43.425000000000004,0.9759533107199466 -146,2019-08-05,-108.17500000000001,43.425000000000004,0.9750527507238025 -146,2019-08-06,-108.17500000000001,43.425000000000004,0.9741790942961157 -146,2019-08-07,-108.17500000000001,43.425000000000004,0.9733275822736092 -146,2019-08-08,-108.17500000000001,43.425000000000004,0.9725005061513914 -146,2019-08-09,-108.17500000000001,43.425000000000004,0.9716888276001966 -146,2019-08-10,-108.17500000000001,43.425000000000004,0.9708962720467689 -146,2019-08-11,-108.17500000000001,43.425000000000004,0.9701187195469465 -146,2019-08-12,-108.17500000000001,43.425000000000004,0.9693531638239629 -146,2019-08-13,-108.17500000000001,43.425000000000004,0.9693403383444933 -146,2019-08-14,-108.17500000000001,43.425000000000004,0.9693314958792509 -146,2019-08-15,-108.17500000000001,43.425000000000004,0.969320018954007 -146,2019-08-16,-108.17500000000001,43.425000000000004,0.9693026580900956 -146,2019-08-17,-108.17500000000001,43.425000000000004,0.9692899745509258 -146,2019-08-18,-108.17500000000001,43.425000000000004,0.9692791015166804 -146,2019-08-19,-108.17500000000001,43.425000000000004,0.9692702160739077 -146,2019-08-20,-108.17500000000001,43.425000000000004,0.9692594030129066 -146,2019-08-21,-108.17500000000001,43.425000000000004,0.9692469406410188 -146,2019-08-22,-108.17500000000001,43.425000000000004,0.9692372518205574 -146,2019-08-23,-108.17500000000001,43.425000000000004,0.9692314695769453 -146,2019-08-24,-108.17500000000001,43.425000000000004,0.9692256727226719 -146,2019-08-25,-108.17500000000001,43.425000000000004,0.9692184314328051 -146,2019-08-26,-108.17500000000001,43.425000000000004,0.9692026110468328 -146,2019-08-27,-108.17500000000001,43.425000000000004,0.9691909246011432 -146,2019-08-28,-108.17500000000001,43.425000000000004,0.9691845365111321 -146,2019-08-29,-108.17500000000001,43.425000000000004,0.9691746558594072 -146,2019-08-30,-108.17500000000001,43.425000000000004,0.9691640571971292 -146,2019-08-31,-108.17500000000001,43.425000000000004,0.9691531935303168 -146,2019-09-01,-108.17500000000001,43.425000000000004,0.9691425153724046 -146,2019-09-02,-108.17500000000001,43.425000000000004,0.9691334898724959 -146,2019-09-03,-108.17500000000001,43.425000000000004,0.9691199184998406 -146,2019-09-04,-108.17500000000001,43.425000000000004,0.9691152532288972 -146,2019-09-05,-108.17500000000001,43.425000000000004,0.9691044133170529 -146,2019-09-06,-108.17500000000001,43.425000000000004,0.9690973657964715 -146,2019-09-07,-108.17500000000001,43.425000000000004,0.9690949755528661 -146,2019-09-08,-108.17500000000001,43.425000000000004,0.9690892220301319 -146,2019-09-09,-108.17500000000001,43.425000000000004,0.9690873962374982 -146,2019-09-10,-108.17500000000001,43.425000000000004,0.9690801479685556 -146,2019-09-11,-108.17500000000001,43.425000000000004,0.969077418307662 -146,2019-09-12,-108.17500000000001,43.425000000000004,0.9690755925150282 -146,2019-09-13,-108.17500000000001,43.425000000000004,0.9690737375572562 -146,2019-09-14,-108.17500000000001,43.425000000000004,0.9690713068826889 -146,2019-09-15,-108.17500000000001,43.425000000000004,0.9690665100469982 -146,2019-09-16,-108.17500000000001,43.425000000000004,0.9690587756853825 -146,2019-09-17,-108.17500000000001,43.425000000000004,0.9690486888887017 -146,2019-09-18,-108.17500000000001,43.425000000000004,0.9690399399693995 -146,2019-09-19,-108.17500000000001,43.425000000000004,0.9690368337248886 -146,2019-09-20,-108.17500000000001,43.425000000000004,0.9690279765806249 -146,2019-09-21,-108.17500000000001,43.425000000000004,0.9690260994210786 -146,2019-09-22,-108.17500000000001,43.425000000000004,0.9690242736284449 -146,2019-09-23,-108.17500000000001,43.425000000000004,0.969022447835811 -146,2019-09-24,-108.17500000000001,43.425000000000004,0.9690206150950751 -146,2019-09-25,-108.17500000000001,43.425000000000004,0.969013622582752 -146,2019-09-26,-108.17500000000001,43.425000000000004,0.9690058389491275 -146,2019-09-27,-108.17500000000001,43.425000000000004,0.9690037065583378 -146,2019-09-28,-108.17500000000001,43.425000000000004,0.9690018807657039 -146,2019-09-29,-108.17500000000001,43.425000000000004,0.9690000549730701 -146,2019-09-30,-108.17500000000001,43.425000000000004,0.9689982291804363 -146,2019-10-01,-108.17500000000001,43.425000000000004,0.9689964033878025 -146,2019-10-02,-108.17500000000001,43.425000000000004,0.9689950074308722 -146,2019-10-03,-108.17500000000001,43.425000000000004,0.968993611473942 -146,2019-10-04,-108.17500000000001,43.425000000000004,0.9689922155170118 -146,2019-10-05,-108.17500000000001,43.425000000000004,0.9689908195600816 -146,2019-10-06,-108.17500000000001,43.425000000000004,0.9689894236031513 -146,2019-10-07,-108.17500000000001,43.425000000000004,0.9689880276462212 -146,2019-10-08,-108.17500000000001,43.425000000000004,0.9689866316892909 -146,2019-10-09,-108.17500000000001,43.425000000000004,0.9689852357323607 -146,2019-10-10,-108.17500000000001,43.425000000000004,0.9689838397754305 -146,2019-10-11,-108.17500000000001,43.425000000000004,0.9689824438185003 -146,2019-10-12,-108.17500000000001,43.425000000000004,0.96898104786157 -146,2019-10-13,-108.17500000000001,43.425000000000004,0.9689796519046399 -146,2019-10-14,-108.17500000000001,43.425000000000004,0.9689782559477096 -146,2019-10-15,-108.17500000000001,43.425000000000004,0.9689768599907794 -146,2019-10-16,-108.17500000000001,43.425000000000004,0.9689754640338492 -146,2019-10-17,-108.17500000000001,43.425000000000004,0.968974068076919 -146,2019-10-18,-108.17500000000001,43.425000000000004,0.9689721479462874 -146,2019-10-19,-108.17500000000001,43.425000000000004,0.9689707519893572 -146,2019-10-20,-108.17500000000001,43.425000000000004,0.968969356032427 -146,2019-10-21,-108.17500000000001,43.425000000000004,0.9689679600754968 -146,2019-10-22,-108.17500000000001,43.425000000000004,0.9689665641185665 -146,2019-10-23,-108.17500000000001,43.425000000000004,0.9689651681616364 -146,2019-10-24,-108.17500000000001,43.425000000000004,0.9689637722047061 -146,2019-10-25,-108.17500000000001,43.425000000000004,0.9689623762477759 -146,2019-10-26,-108.17500000000001,43.425000000000004,0.9689609802908457 -146,2019-10-27,-108.17500000000001,43.425000000000004,0.9689595843339155 -146,2019-10-28,-108.17500000000001,43.425000000000004,0.9689581883769852 -146,2019-10-29,-108.17500000000001,43.425000000000004,0.9689567924200551 -146,2019-10-30,-108.17500000000001,43.425000000000004,0.9689553964631248 -146,2019-10-31,-108.17500000000001,43.425000000000004,0.9689540005061946 -146,2019-11-01,-108.17500000000001,43.425000000000004,0.9689526045492644 -146,2019-11-02,-108.17500000000001,43.425000000000004,0.9689512493383546 -146,2019-11-03,-108.17500000000001,43.425000000000004,0.9689498941274449 -146,2019-11-04,-108.17500000000001,43.425000000000004,0.9689485389165352 -146,2019-11-05,-108.17500000000001,43.425000000000004,0.9689471837056255 -146,2019-11-06,-108.17500000000001,43.425000000000004,0.9689458284947158 -146,2019-11-07,-108.17500000000001,43.425000000000004,0.9689444732838061 -146,2019-11-08,-108.17500000000001,43.425000000000004,0.9689431180728963 -146,2019-11-09,-108.17500000000001,43.425000000000004,0.9689417628619866 -146,2019-11-10,-108.17500000000001,43.425000000000004,0.9689404076510769 -146,2019-11-11,-108.17500000000001,43.425000000000004,0.9689390524401672 -146,2019-11-12,-108.17500000000001,43.425000000000004,0.9689376972292575 -146,2019-11-13,-108.17500000000001,43.425000000000004,0.9689363420183478 -146,2019-11-14,-108.17500000000001,43.425000000000004,0.9689349868074381 -146,2019-11-15,-108.17500000000001,43.425000000000004,0.9689336315965283 -146,2019-11-16,-108.17500000000001,43.425000000000004,0.9689322763856186 -146,2019-11-17,-108.17500000000001,43.425000000000004,0.9689309211747089 -146,2019-11-18,-108.17500000000001,43.425000000000004,0.9689295659637992 -146,2019-11-19,-108.17500000000001,43.425000000000004,0.9689282107528896 -146,2019-11-20,-108.17500000000001,43.425000000000004,0.9689268555419799 -146,2019-11-21,-108.17500000000001,43.425000000000004,0.9689255003310702 -146,2019-11-22,-108.17500000000001,43.425000000000004,0.9689241451201605 -146,2019-11-23,-108.17500000000001,43.425000000000004,0.9689227899092507 -146,2019-11-24,-108.17500000000001,43.425000000000004,0.968921434698341 -146,2019-11-25,-108.17500000000001,43.425000000000004,0.9689200794874313 -146,2019-11-26,-108.17500000000001,43.425000000000004,0.9689187242765216 -146,2019-11-27,-108.17500000000001,43.425000000000004,0.9689173690656119 -146,2019-11-28,-108.17500000000001,43.425000000000004,0.9689160138547022 -146,2019-11-29,-108.17500000000001,43.425000000000004,0.9689146586437924 -146,2019-11-30,-108.17500000000001,43.425000000000004,0.9689133034328827 -146,2019-12-01,-108.17500000000001,43.425000000000004,0.968911948221973 -146,2019-12-02,-108.17500000000001,43.425000000000004,0.9689107957991658 -146,2019-12-03,-108.17500000000001,43.425000000000004,0.9689096433763587 -146,2019-12-04,-108.17500000000001,43.425000000000004,0.9689084909535514 -146,2019-12-05,-108.17500000000001,43.425000000000004,0.9689073385307442 -146,2019-12-06,-108.17500000000001,43.425000000000004,0.968906186107937 -146,2019-12-07,-108.17500000000001,43.425000000000004,0.9689050336851298 -146,2019-12-08,-108.17500000000001,43.425000000000004,0.9689038812623226 -146,2019-12-09,-108.17500000000001,43.425000000000004,0.9689027288395154 -146,2019-12-10,-108.17500000000001,43.425000000000004,0.9689015764167083 -146,2019-12-11,-108.17500000000001,43.425000000000004,0.9689004239939011 -146,2019-12-12,-108.17500000000001,43.425000000000004,0.9688992715710939 -146,2019-12-13,-108.17500000000001,43.425000000000004,0.9688981191482866 -146,2019-12-14,-108.17500000000001,43.425000000000004,0.9688969667254794 -146,2019-12-15,-108.17500000000001,43.425000000000004,0.9688958143026722 -146,2019-12-16,-108.17500000000001,43.425000000000004,0.9688946618798651 -146,2019-12-17,-108.17500000000001,43.425000000000004,0.9688935094570579 -146,2019-12-18,-108.17500000000001,43.425000000000004,0.9688923570342507 -146,2019-12-19,-108.17500000000001,43.425000000000004,0.9688912046114435 -146,2019-12-20,-108.17500000000001,43.425000000000004,0.9688900521886363 -146,2019-12-21,-108.17500000000001,43.425000000000004,0.9688888997658291 -146,2019-12-22,-108.17500000000001,43.425000000000004,0.9688877473430219 -146,2019-12-23,-108.17500000000001,43.425000000000004,0.9688865949202147 -146,2019-12-24,-108.17500000000001,43.425000000000004,0.9688854424974075 -146,2019-12-25,-108.17500000000001,43.425000000000004,0.9688842900746003 -146,2019-12-26,-108.17500000000001,43.425000000000004,0.9688831376517931 -146,2019-12-27,-108.17500000000001,43.425000000000004,0.9688819852289859 -146,2019-12-28,-108.17500000000001,43.425000000000004,0.9688808328061788 -146,2019-12-29,-108.17500000000001,43.425000000000004,0.9688796803833716 -146,2019-12-30,-108.17500000000001,43.425000000000004,0.9688785279605644 -146,2019-12-31,-108.17500000000001,43.425000000000004,0.9688773755377571 -146,2020-01-01,-108.17500000000001,43.425000000000004,0.9688762231149499 -169,2018-01-02,-111.12500000000001,48.325,0.9682263514912761 -169,2018-01-03,-111.12500000000001,48.325,0.9682247634335215 -169,2018-01-04,-111.12500000000001,48.325,0.9682231753757669 -169,2018-01-05,-111.12500000000001,48.325,0.9682215873180122 -169,2018-01-06,-111.12500000000001,48.325,0.9682199992602577 -169,2018-01-07,-111.12500000000001,48.325,0.9682184112025031 -169,2018-01-08,-111.12500000000001,48.325,0.9682168231447484 -169,2018-01-09,-111.12500000000001,48.325,0.9682152350869938 -169,2018-01-10,-111.12500000000001,48.325,0.9682136470292393 -169,2018-01-11,-111.12500000000001,48.325,0.9682120589714847 -169,2018-01-12,-111.12500000000001,48.325,0.96821047091373 -169,2018-01-13,-111.12500000000001,48.325,0.9682088828559754 -169,2018-01-14,-111.12500000000001,48.325,0.9682072947982209 -169,2018-01-15,-111.12500000000001,48.325,0.9682057067404662 -169,2018-01-16,-111.12500000000001,48.325,0.9682041186827116 -169,2018-01-17,-111.12500000000001,48.325,0.968202530624957 -169,2018-01-18,-111.12500000000001,48.325,0.9682009425672023 -169,2018-01-19,-111.12500000000001,48.325,0.9681993545094478 -169,2018-01-20,-111.12500000000001,48.325,0.9681977664516932 -169,2018-01-21,-111.12500000000001,48.325,0.9681961783939386 -169,2018-01-22,-111.12500000000001,48.325,0.9681945903361839 -169,2018-01-23,-111.12500000000001,48.325,0.9681930022784294 -169,2018-01-24,-111.12500000000001,48.325,0.9681914142206748 -169,2018-01-25,-111.12500000000001,48.325,0.9681898261629202 -169,2018-01-26,-111.12500000000001,48.325,0.9681882381051655 -169,2018-01-27,-111.12500000000001,48.325,0.968186650047411 -169,2018-01-28,-111.12500000000001,48.325,0.9681850619896564 -169,2018-01-29,-111.12500000000001,48.325,0.9681834739319017 -169,2018-01-30,-111.12500000000001,48.325,0.9681818858741471 -169,2018-01-31,-111.12500000000001,48.325,0.9681802978163925 -169,2018-02-01,-111.12500000000001,48.325,0.968178709758638 -169,2018-02-02,-111.12500000000001,48.325,0.9681771764364503 -169,2018-02-03,-111.12500000000001,48.325,0.9681756431142627 -169,2018-02-04,-111.12500000000001,48.325,0.9681741097920751 -169,2018-02-05,-111.12500000000001,48.325,0.9681725764698875 -169,2018-02-06,-111.12500000000001,48.325,0.9681710431476999 -169,2018-02-07,-111.12500000000001,48.325,0.9681695098255123 -169,2018-02-08,-111.12500000000001,48.325,0.9681679765033248 -169,2018-02-09,-111.12500000000001,48.325,0.9681664431811371 -169,2018-02-10,-111.12500000000001,48.325,0.9681649098589495 -169,2018-02-11,-111.12500000000001,48.325,0.9681633765367619 -169,2018-02-12,-111.12500000000001,48.325,0.9681618432145743 -169,2018-02-13,-111.12500000000001,48.325,0.9681603098923867 -169,2018-02-14,-111.12500000000001,48.325,0.9681587765701991 -169,2018-02-15,-111.12500000000001,48.325,0.9681572432480114 -169,2018-02-16,-111.12500000000001,48.325,0.9681557099258239 -169,2018-02-17,-111.12500000000001,48.325,0.9681541766036363 -169,2018-02-18,-111.12500000000001,48.325,0.9681526432814487 -169,2018-02-19,-111.12500000000001,48.325,0.9681511099592611 -169,2018-02-20,-111.12500000000001,48.325,0.9681495766370735 -169,2018-02-21,-111.12500000000001,48.325,0.9681480433148859 -169,2018-02-22,-111.12500000000001,48.325,0.9681465099926982 -169,2018-02-23,-111.12500000000001,48.325,0.9681449766705107 -169,2018-02-24,-111.12500000000001,48.325,0.9681434433483231 -169,2018-02-25,-111.12500000000001,48.325,0.9681419100261355 -169,2018-02-26,-111.12500000000001,48.325,0.9681403767039479 -169,2018-02-27,-111.12500000000001,48.325,0.9681388433817603 -169,2018-02-28,-111.12500000000001,48.325,0.9681373100595727 -169,2018-03-01,-111.12500000000001,48.325,0.968135776737385 -169,2018-03-02,-111.12500000000001,48.325,0.968134107984579 -169,2018-03-03,-111.12500000000001,48.325,0.968132439231773 -169,2018-03-04,-111.12500000000001,48.325,0.9681307704789669 -169,2018-03-05,-111.12500000000001,48.325,0.9681291017261608 -169,2018-03-06,-111.12500000000001,48.325,0.9681274329733548 -169,2018-03-07,-111.12500000000001,48.325,0.9681257642205486 -169,2018-03-08,-111.12500000000001,48.325,0.9681240954677426 -169,2018-03-09,-111.12500000000001,48.325,0.9681224267149365 -169,2018-03-10,-111.12500000000001,48.325,0.9681207579621305 -169,2018-03-11,-111.12500000000001,48.325,0.9681190892093244 -169,2018-03-12,-111.12500000000001,48.325,0.9681174204565184 -169,2018-03-13,-111.12500000000001,48.325,0.9681157517037123 -169,2018-03-14,-111.12500000000001,48.325,0.9681140829509062 -169,2018-03-15,-111.12500000000001,48.325,0.9681124141981001 -169,2018-03-16,-111.12500000000001,48.325,0.9681107454452941 -169,2018-03-17,-111.12500000000001,48.325,0.968109076692488 -169,2018-03-18,-111.12500000000001,48.325,0.968107407939682 -169,2018-03-19,-111.12500000000001,48.325,0.9681057391868759 -169,2018-03-20,-111.12500000000001,48.325,0.9681040704340699 -169,2018-03-21,-111.12500000000001,48.325,0.9681024016812638 -169,2018-03-22,-111.12500000000001,48.325,0.9681007329284577 -169,2018-03-23,-111.12500000000001,48.325,0.9680990641756516 -169,2018-03-24,-111.12500000000001,48.325,0.9680973954228456 -169,2018-03-25,-111.12500000000001,48.325,0.9680957266700395 -169,2018-03-26,-111.12500000000001,48.325,0.9680940579172335 -169,2018-03-27,-111.12500000000001,48.325,0.9680923891644274 -169,2018-03-28,-111.12500000000001,48.325,0.9680907204116214 -169,2018-03-29,-111.12500000000001,48.325,0.9680890516588152 -169,2018-03-30,-111.12500000000001,48.325,0.9680873829060092 -169,2018-03-31,-111.12500000000001,48.325,0.9680857141532031 -169,2018-04-01,-111.12500000000001,48.325,0.968084045400397 -169,2018-04-02,-111.12500000000001,48.325,0.9680821601656172 -169,2018-04-03,-111.12500000000001,48.325,0.9680802749308374 -169,2018-04-04,-111.12500000000001,48.325,0.9680783896960575 -169,2018-04-05,-111.12500000000001,48.325,0.9680765044612778 -169,2018-04-06,-111.12500000000001,48.325,0.968074619226498 -169,2018-04-07,-111.12500000000001,48.325,0.9680727339917181 -169,2018-04-08,-111.12500000000001,48.325,0.9680708487569383 -169,2018-04-09,-111.12500000000001,48.325,0.9680689635221584 -169,2018-04-10,-111.12500000000001,48.325,0.9680670782873786 -169,2018-04-11,-111.12500000000001,48.325,0.9680651930525987 -169,2018-04-12,-111.12500000000001,48.325,0.9680633078178189 -169,2018-04-13,-111.12500000000001,48.325,0.9680614225830392 -169,2018-04-14,-111.12500000000001,48.325,0.9680595373482593 -169,2018-04-15,-111.12500000000001,48.325,0.9680576521134795 -169,2018-04-16,-111.12500000000001,48.325,0.9680557668786997 -169,2018-04-17,-111.12500000000001,48.325,0.9680538816439198 -169,2018-04-18,-111.12500000000001,48.325,0.96805199640914 -169,2018-04-19,-111.12500000000001,48.325,0.9680501111743601 -169,2018-04-20,-111.12500000000001,48.325,0.9680482259395804 -169,2018-04-21,-111.12500000000001,48.325,0.9680463407048006 -169,2018-04-22,-111.12500000000001,48.325,0.9680444554700207 -169,2018-04-23,-111.12500000000001,48.325,0.9680425702352409 -169,2018-04-24,-111.12500000000001,48.325,0.9677348128020521 -169,2018-04-25,-111.12500000000001,48.325,0.9677793454232093 -169,2018-04-26,-111.12500000000001,48.325,0.9680107308488222 -169,2018-04-27,-111.12500000000001,48.325,0.9682865605155533 -169,2018-04-28,-111.12500000000001,48.325,0.9685677449043945 -169,2018-04-29,-111.12500000000001,48.325,0.9688870669424673 -169,2018-04-30,-111.12500000000001,48.325,0.9692752706840986 -169,2018-05-01,-111.12500000000001,48.325,0.969754633156897 -169,2018-05-02,-111.12500000000001,48.325,0.9703104901745873 -169,2018-05-03,-111.12500000000001,48.325,0.9708448914570952 -169,2018-05-04,-111.12500000000001,48.325,0.9712575048037531 -169,2018-05-05,-111.12500000000001,48.325,0.9715128217486099 -169,2018-05-06,-111.12500000000001,48.325,0.9716522650992767 -169,2018-05-07,-111.12500000000001,48.325,0.9717182956380502 -169,2018-05-08,-111.12500000000001,48.325,0.9717935789529687 -169,2018-05-09,-111.12500000000001,48.325,0.9719234818908108 -169,2018-05-10,-111.12500000000001,48.325,0.9721463088404019 -169,2018-05-11,-111.12500000000001,48.325,0.9725649310835426 -169,2018-05-12,-111.12500000000001,48.325,0.9733449248792764 -169,2018-05-13,-111.12500000000001,48.325,0.9744412976669636 -169,2018-05-14,-111.12500000000001,48.325,0.9755864926376114 -169,2018-05-15,-111.12500000000001,48.325,0.9767400493381309 -169,2018-05-16,-111.12500000000001,48.325,0.9778038612288867 -169,2018-05-17,-111.12500000000001,48.325,0.9788992644952994 -169,2018-05-18,-111.12500000000001,48.325,0.9804317177475935 -169,2018-05-19,-111.12500000000001,48.325,0.9827107219665309 -169,2018-05-20,-111.12500000000001,48.325,0.9840525380712519 -169,2018-05-21,-111.12500000000001,48.325,0.9844494881172705 -169,2018-05-22,-111.12500000000001,48.325,0.9845057932054071 -169,2018-05-23,-111.12500000000001,48.325,0.9844570568319967 -169,2018-05-24,-111.12500000000001,48.325,0.9845396966536508 -169,2018-05-25,-111.12500000000001,48.325,0.9847251370933199 -169,2018-05-26,-111.12500000000001,48.325,0.9848355499481476 -169,2018-05-27,-111.12500000000001,48.325,0.984847070428188 -169,2018-05-28,-111.12500000000001,48.325,0.9848367476018542 -169,2018-05-29,-111.12500000000001,48.325,0.9847778895745942 -169,2018-05-30,-111.12500000000001,48.325,0.9846657132308672 -169,2018-05-31,-111.12500000000001,48.325,0.9845716646766222 -169,2018-06-01,-111.12500000000001,48.325,0.9845663771388171 -169,2018-06-02,-111.12500000000001,48.325,0.984683032333572 -169,2018-06-03,-111.12500000000001,48.325,0.9847495067879727 -169,2018-06-04,-111.12500000000001,48.325,0.9847666826979391 -169,2018-06-05,-111.12500000000001,48.325,0.984737952904594 -169,2018-06-06,-111.12500000000001,48.325,0.9845770229089605 -169,2018-06-07,-111.12500000000001,48.325,0.9843482938346111 -169,2018-06-08,-111.12500000000001,48.325,0.9841284237317768 -169,2018-06-09,-111.12500000000001,48.325,0.9839429173266601 -169,2018-06-10,-111.12500000000001,48.325,0.983789645879795 -169,2018-06-11,-111.12500000000001,48.325,0.9836766595213435 -169,2018-06-12,-111.12500000000001,48.325,0.9835945043326537 -169,2018-06-13,-111.12500000000001,48.325,0.9835393205338314 -169,2018-06-14,-111.12500000000001,48.325,0.9835078679899973 -169,2018-06-15,-111.12500000000001,48.325,0.9834553147255043 -169,2018-06-16,-111.12500000000001,48.325,0.9833723294091402 -169,2018-06-17,-111.12500000000001,48.325,0.9833398207283606 -169,2018-06-18,-111.12500000000001,48.325,0.983333561919298 -169,2018-06-19,-111.12500000000001,48.325,0.9834004221113328 -169,2018-06-20,-111.12500000000001,48.325,0.9835646301749918 -169,2018-06-21,-111.12500000000001,48.325,0.9836539017839228 -169,2018-06-22,-111.12500000000001,48.325,0.9836679798376532 -169,2018-06-23,-111.12500000000001,48.325,0.9836572665306477 -169,2018-06-24,-111.12500000000001,48.325,0.9835742331980524 -169,2018-06-25,-111.12500000000001,48.325,0.9834435369420466 -169,2018-06-26,-111.12500000000001,48.325,0.983304467844793 -169,2018-06-27,-111.12500000000001,48.325,0.9831634846367373 -169,2018-06-28,-111.12500000000001,48.325,0.9830131034957372 -169,2018-06-29,-111.12500000000001,48.325,0.9828977754273632 -169,2018-06-30,-111.12500000000001,48.325,0.9828479352818643 -169,2018-07-01,-111.12500000000001,48.325,0.9828137281599877 -169,2018-07-02,-111.12500000000001,48.325,0.9827578523639355 -169,2018-07-03,-111.12500000000001,48.325,0.9827016854633479 -169,2018-07-04,-111.12500000000001,48.325,0.9826392763794402 -169,2018-07-05,-111.12500000000001,48.325,0.9825857481676953 -169,2018-07-06,-111.12500000000001,48.325,0.9825336608425577 -169,2018-07-07,-111.12500000000001,48.325,0.9824377943654923 -169,2018-07-08,-111.12500000000001,48.325,0.9822441138762589 -169,2018-07-09,-111.12500000000001,48.325,0.9819835406236235 -169,2018-07-10,-111.12500000000001,48.325,0.9816777715649659 -169,2018-07-11,-111.12500000000001,48.325,0.9813271459613505 -169,2018-07-12,-111.12500000000001,48.325,0.9809419435450867 -169,2018-07-13,-111.12500000000001,48.325,0.9804872573359636 -169,2018-07-14,-111.12500000000001,48.325,0.9800039661936532 -169,2018-07-15,-111.12500000000001,48.325,0.9795355006745566 -169,2018-07-16,-111.12500000000001,48.325,0.9790662772565856 -169,2018-07-17,-111.12500000000001,48.325,0.978598345427266 -169,2018-07-18,-111.12500000000001,48.325,0.9781393496600876 -169,2018-07-19,-111.12500000000001,48.325,0.977689503352125 -169,2018-07-20,-111.12500000000001,48.325,0.9772485857097155 -169,2018-07-21,-111.12500000000001,48.325,0.9768094082083159 -169,2018-07-22,-111.12500000000001,48.325,0.9763925512486118 -169,2018-07-23,-111.12500000000001,48.325,0.9759747391000613 -169,2018-07-24,-111.12500000000001,48.325,0.9755696697645 -169,2018-07-25,-111.12500000000001,48.325,0.9751683705074312 -169,2018-07-26,-111.12500000000001,48.325,0.9747652128276351 -169,2018-07-27,-111.12500000000001,48.325,0.9743560979195334 -169,2018-07-28,-111.12500000000001,48.325,0.9739489126302313 -169,2018-07-29,-111.12500000000001,48.325,0.9735496186327656 -169,2018-07-30,-111.12500000000001,48.325,0.9731528477343895 -169,2018-07-31,-111.12500000000001,48.325,0.9727554386743366 -169,2018-08-01,-111.12500000000001,48.325,0.9723823674416106 -169,2018-08-02,-111.12500000000001,48.325,0.9720016441176532 -169,2018-08-03,-111.12500000000001,48.325,0.9716123622724664 -169,2018-08-04,-111.12500000000001,48.325,0.9712568000281637 -169,2018-08-05,-111.12500000000001,48.325,0.9708931211582976 -169,2018-08-06,-111.12500000000001,48.325,0.9705312600437493 -169,2018-08-07,-111.12500000000001,48.325,0.9701605421844879 -169,2018-08-08,-111.12500000000001,48.325,0.9697877250663477 -169,2018-08-09,-111.12500000000001,48.325,0.9696997125206435 -169,2018-08-10,-111.12500000000001,48.325,0.9696828841076102 -169,2018-08-11,-111.12500000000001,48.325,0.9696464188778384 -169,2018-08-12,-111.12500000000001,48.325,0.9696160877438501 -169,2018-08-13,-111.12500000000001,48.325,0.9695884206329842 -169,2018-08-14,-111.12500000000001,48.325,0.9695840810794636 -169,2018-08-15,-111.12500000000001,48.325,0.9695719176085533 -169,2018-08-16,-111.12500000000001,48.325,0.9695413092244605 -169,2018-08-17,-111.12500000000001,48.325,0.9695144777742994 -169,2018-08-18,-111.12500000000001,48.325,0.9694974627008578 -169,2018-08-19,-111.12500000000001,48.325,0.969466025047379 -169,2018-08-20,-111.12500000000001,48.325,0.9694509790407898 -169,2018-08-21,-111.12500000000001,48.325,0.9694486280231502 -169,2018-08-22,-111.12500000000001,48.325,0.9694460217683909 -169,2018-08-23,-111.12500000000001,48.325,0.9694267142135513 -169,2018-08-24,-111.12500000000001,48.325,0.9694095992513377 -169,2018-08-25,-111.12500000000001,48.325,0.9693959820506449 -169,2018-08-26,-111.12500000000001,48.325,0.969392101865225 -169,2018-08-27,-111.12500000000001,48.325,0.9693854329080166 -169,2018-08-28,-111.12500000000001,48.325,0.9693830818903769 -169,2018-08-29,-111.12500000000001,48.325,0.9693807308727374 -169,2018-08-30,-111.12500000000001,48.325,0.9693716655762952 -169,2018-08-31,-111.12500000000001,48.325,0.9693668554507395 -169,2018-09-01,-111.12500000000001,48.325,0.9693645044330998 -169,2018-09-02,-111.12500000000001,48.325,0.9693618314177248 -169,2018-09-03,-111.12500000000001,48.325,0.9693491517143373 -169,2018-09-04,-111.12500000000001,48.325,0.9693398099279491 -169,2018-09-05,-111.12500000000001,48.325,0.9693376060134455 -169,2018-09-06,-111.12500000000001,48.325,0.9693344526585495 -169,2018-09-07,-111.12500000000001,48.325,0.969329629209814 -169,2018-09-08,-111.12500000000001,48.325,0.9693241316897186 -169,2018-09-09,-111.12500000000001,48.325,0.9693077311337664 -169,2018-09-10,-111.12500000000001,48.325,0.9693017232428764 -169,2018-09-11,-111.12500000000001,48.325,0.9692960045213752 -169,2018-09-12,-111.12500000000001,48.325,0.9692936545806713 -169,2018-09-13,-111.12500000000001,48.325,0.9692913605058509 -169,2018-09-14,-111.12500000000001,48.325,0.9692891565913473 -169,2018-09-15,-111.12500000000001,48.325,0.9692869526768438 -169,2018-09-16,-111.12500000000001,48.325,0.9692847487623403 -169,2018-09-17,-111.12500000000001,48.325,0.9692825448478367 -169,2018-09-18,-111.12500000000001,48.325,0.9692803409333333 -169,2018-09-19,-111.12500000000001,48.325,0.9692781370188297 -169,2018-09-20,-111.12500000000001,48.325,0.9692759331043261 -169,2018-09-21,-111.12500000000001,48.325,0.9692737291898227 -169,2018-09-22,-111.12500000000001,48.325,0.9692715252753191 -169,2018-09-23,-111.12500000000001,48.325,0.9692693213608156 -169,2018-09-24,-111.12500000000001,48.325,0.9692671174463121 -169,2018-09-25,-111.12500000000001,48.325,0.9692649135318085 -169,2018-09-26,-111.12500000000001,48.325,0.969262709617305 -169,2018-09-27,-111.12500000000001,48.325,0.9692605057028014 -169,2018-09-28,-111.12500000000001,48.325,0.969258301788298 -169,2018-09-29,-111.12500000000001,48.325,0.9692560978737944 -169,2018-09-30,-111.12500000000001,48.325,0.9692538939592908 -169,2018-10-01,-111.12500000000001,48.325,0.9692516900447874 -169,2018-10-02,-111.12500000000001,48.325,0.9692497657491985 -169,2018-10-03,-111.12500000000001,48.325,0.9692478414536096 -169,2018-10-04,-111.12500000000001,48.325,0.9692459171580208 -169,2018-10-05,-111.12500000000001,48.325,0.9692439928624319 -169,2018-10-06,-111.12500000000001,48.325,0.969242068566843 -169,2018-10-07,-111.12500000000001,48.325,0.9692401442712542 -169,2018-10-08,-111.12500000000001,48.325,0.9692382199756653 -169,2018-10-09,-111.12500000000001,48.325,0.9692362956800764 -169,2018-10-10,-111.12500000000001,48.325,0.9692343713844875 -169,2018-10-11,-111.12500000000001,48.325,0.9692324470888987 -169,2018-10-12,-111.12500000000001,48.325,0.9692305227933098 -169,2018-10-13,-111.12500000000001,48.325,0.9692285984977209 -169,2018-10-14,-111.12500000000001,48.325,0.969226674202132 -169,2018-10-15,-111.12500000000001,48.325,0.9692247499065432 -169,2018-10-16,-111.12500000000001,48.325,0.9692228256109543 -169,2018-10-17,-111.12500000000001,48.325,0.9692209013153654 -169,2018-10-18,-111.12500000000001,48.325,0.9692189770197766 -169,2018-10-19,-111.12500000000001,48.325,0.9692170527241877 -169,2018-10-20,-111.12500000000001,48.325,0.9692151284285988 -169,2018-10-21,-111.12500000000001,48.325,0.9692132041330099 -169,2018-10-22,-111.12500000000001,48.325,0.9692112798374211 -169,2018-10-23,-111.12500000000001,48.325,0.9692093555418322 -169,2018-10-24,-111.12500000000001,48.325,0.9692074312462433 -169,2018-10-25,-111.12500000000001,48.325,0.9692055069506544 -169,2018-10-26,-111.12500000000001,48.325,0.9692035826550656 -169,2018-10-27,-111.12500000000001,48.325,0.9692016583594767 -169,2018-10-28,-111.12500000000001,48.325,0.9691997340638878 -169,2018-10-29,-111.12500000000001,48.325,0.969197809768299 -169,2018-10-30,-111.12500000000001,48.325,0.9691958854727101 -169,2018-10-31,-111.12500000000001,48.325,0.9691939611771212 -169,2018-11-01,-111.12500000000001,48.325,0.9691920368815323 -169,2018-11-02,-111.12500000000001,48.325,0.9691902562026866 -169,2018-11-03,-111.12500000000001,48.325,0.969188475523841 -169,2018-11-04,-111.12500000000001,48.325,0.9691866948449953 -169,2018-11-05,-111.12500000000001,48.325,0.9691849141661496 -169,2018-11-06,-111.12500000000001,48.325,0.969183133487304 -169,2018-11-07,-111.12500000000001,48.325,0.9691813528084583 -169,2018-11-08,-111.12500000000001,48.325,0.9691795721296127 -169,2018-11-09,-111.12500000000001,48.325,0.969177791450767 -169,2018-11-10,-111.12500000000001,48.325,0.9691760107719213 -169,2018-11-11,-111.12500000000001,48.325,0.9691742300930757 -169,2018-11-12,-111.12500000000001,48.325,0.96917244941423 -169,2018-11-13,-111.12500000000001,48.325,0.9691706687353844 -169,2018-11-14,-111.12500000000001,48.325,0.9691688880565387 -169,2018-11-15,-111.12500000000001,48.325,0.969167107377693 -169,2018-11-16,-111.12500000000001,48.325,0.9691653266988474 -169,2018-11-17,-111.12500000000001,48.325,0.9691635460200017 -169,2018-11-18,-111.12500000000001,48.325,0.9691617653411561 -169,2018-11-19,-111.12500000000001,48.325,0.9691599846623103 -169,2018-11-20,-111.12500000000001,48.325,0.9691582039834646 -169,2018-11-21,-111.12500000000001,48.325,0.969156423304619 -169,2018-11-22,-111.12500000000001,48.325,0.9691546426257733 -169,2018-11-23,-111.12500000000001,48.325,0.9691528619469277 -169,2018-11-24,-111.12500000000001,48.325,0.969151081268082 -169,2018-11-25,-111.12500000000001,48.325,0.9691493005892365 -169,2018-11-26,-111.12500000000001,48.325,0.9691475199103909 -169,2018-11-27,-111.12500000000001,48.325,0.9691457392315452 -169,2018-11-28,-111.12500000000001,48.325,0.9691439585526995 -169,2018-11-29,-111.12500000000001,48.325,0.9691421778738539 -169,2018-11-30,-111.12500000000001,48.325,0.9691403971950082 -169,2018-12-01,-111.12500000000001,48.325,0.9691386165161626 -169,2018-12-02,-111.12500000000001,48.325,0.9691369923901829 -169,2018-12-03,-111.12500000000001,48.325,0.9691353682642031 -169,2018-12-04,-111.12500000000001,48.325,0.9691337441382234 -169,2018-12-05,-111.12500000000001,48.325,0.9691321200122437 -169,2018-12-06,-111.12500000000001,48.325,0.969130495886264 -169,2018-12-07,-111.12500000000001,48.325,0.9691288717602843 -169,2018-12-08,-111.12500000000001,48.325,0.9691272476343046 -169,2018-12-09,-111.12500000000001,48.325,0.9691256235083249 -169,2018-12-10,-111.12500000000001,48.325,0.9691239993823452 -169,2018-12-11,-111.12500000000001,48.325,0.9691223752563655 -169,2018-12-12,-111.12500000000001,48.325,0.9691207511303858 -169,2018-12-13,-111.12500000000001,48.325,0.9691191270044061 -169,2018-12-14,-111.12500000000001,48.325,0.9691175028784262 -169,2018-12-15,-111.12500000000001,48.325,0.9691158787524465 -169,2018-12-16,-111.12500000000001,48.325,0.9691142546264668 -169,2018-12-17,-111.12500000000001,48.325,0.9691126305004871 -169,2018-12-18,-111.12500000000001,48.325,0.9691110063745074 -169,2018-12-19,-111.12500000000001,48.325,0.9691093822485277 -169,2018-12-20,-111.12500000000001,48.325,0.969107758122548 -169,2018-12-21,-111.12500000000001,48.325,0.9691061339965683 -169,2018-12-22,-111.12500000000001,48.325,0.9691045098705886 -169,2018-12-23,-111.12500000000001,48.325,0.9691028857446089 -169,2018-12-24,-111.12500000000001,48.325,0.9691012616186292 -169,2018-12-25,-111.12500000000001,48.325,0.9690996374926494 -169,2018-12-26,-111.12500000000001,48.325,0.9690980133666697 -169,2018-12-27,-111.12500000000001,48.325,0.96909638924069 -169,2018-12-28,-111.12500000000001,48.325,0.9690947651147103 -169,2018-12-29,-111.12500000000001,48.325,0.9690931409887306 -169,2018-12-30,-111.12500000000001,48.325,0.9690915168627509 -169,2018-12-31,-111.12500000000001,48.325,0.9690898927367712 -169,2019-01-01,-111.12500000000001,48.325,0.9690882686107914 -169,2019-01-02,-111.12500000000001,48.325,0.9690865890499165 -169,2019-01-03,-111.12500000000001,48.325,0.9690849094890417 -169,2019-01-04,-111.12500000000001,48.325,0.9690832299281668 -169,2019-01-05,-111.12500000000001,48.325,0.9690815503672919 -169,2019-01-06,-111.12500000000001,48.325,0.969079870806417 -169,2019-01-07,-111.12500000000001,48.325,0.9690781912455422 -169,2019-01-08,-111.12500000000001,48.325,0.9690765116846672 -169,2019-01-09,-111.12500000000001,48.325,0.9690748321237924 -169,2019-01-10,-111.12500000000001,48.325,0.9690731525629173 -169,2019-01-11,-111.12500000000001,48.325,0.9690714730020424 -169,2019-01-12,-111.12500000000001,48.325,0.9690697934411675 -169,2019-01-13,-111.12500000000001,48.325,0.9690681138802927 -169,2019-01-14,-111.12500000000001,48.325,0.9690664343194177 -169,2019-01-15,-111.12500000000001,48.325,0.9690647547585429 -169,2019-01-16,-111.12500000000001,48.325,0.969063075197668 -169,2019-01-17,-111.12500000000001,48.325,0.9690613956367932 -169,2019-01-18,-111.12500000000001,48.325,0.9690597160759182 -169,2019-01-19,-111.12500000000001,48.325,0.9690580365150433 -169,2019-01-20,-111.12500000000001,48.325,0.9690563569541685 -169,2019-01-21,-111.12500000000001,48.325,0.9690546773932935 -169,2019-01-22,-111.12500000000001,48.325,0.9690529978324187 -169,2019-01-23,-111.12500000000001,48.325,0.9690513182715438 -169,2019-01-24,-111.12500000000001,48.325,0.969049638710669 -169,2019-01-25,-111.12500000000001,48.325,0.969047959149794 -169,2019-01-26,-111.12500000000001,48.325,0.9690462795889192 -169,2019-01-27,-111.12500000000001,48.325,0.9690446000280443 -169,2019-01-28,-111.12500000000001,48.325,0.9690429204671694 -169,2019-01-29,-111.12500000000001,48.325,0.9690412409062945 -169,2019-01-30,-111.12500000000001,48.325,0.9690395613454197 -169,2019-01-31,-111.12500000000001,48.325,0.9690378817845448 -169,2019-02-01,-111.12500000000001,48.325,0.9690362022236699 -169,2019-02-02,-111.12500000000001,48.325,0.9690347482850643 -169,2019-02-03,-111.12500000000001,48.325,0.9690332943464586 -169,2019-02-04,-111.12500000000001,48.325,0.969031840407853 -169,2019-02-05,-111.12500000000001,48.325,0.9690303864692473 -169,2019-02-06,-111.12500000000001,48.325,0.9690289325306417 -169,2019-02-07,-111.12500000000001,48.325,0.9690274785920361 -169,2019-02-08,-111.12500000000001,48.325,0.9690260246534305 -169,2019-02-09,-111.12500000000001,48.325,0.9690245707148248 -169,2019-02-10,-111.12500000000001,48.325,0.9690231167762192 -169,2019-02-11,-111.12500000000001,48.325,0.9690216628376136 -169,2019-02-12,-111.12500000000001,48.325,0.969020208899008 -169,2019-02-13,-111.12500000000001,48.325,0.9690187549604024 -169,2019-02-14,-111.12500000000001,48.325,0.9690173010217967 -169,2019-02-15,-111.12500000000001,48.325,0.9690158470831911 -169,2019-02-16,-111.12500000000001,48.325,0.9690143931445855 -169,2019-02-17,-111.12500000000001,48.325,0.9690129392059799 -169,2019-02-18,-111.12500000000001,48.325,0.9690114852673742 -169,2019-02-19,-111.12500000000001,48.325,0.9690100313287686 -169,2019-02-20,-111.12500000000001,48.325,0.969008577390163 -169,2019-02-21,-111.12500000000001,48.325,0.9690071234515574 -169,2019-02-22,-111.12500000000001,48.325,0.9690056695129518 -169,2019-02-23,-111.12500000000001,48.325,0.9690042155743461 -169,2019-02-24,-111.12500000000001,48.325,0.9690027616357405 -169,2019-02-25,-111.12500000000001,48.325,0.9690013076971349 -169,2019-02-26,-111.12500000000001,48.325,0.9689998537585293 -169,2019-02-27,-111.12500000000001,48.325,0.9689983998199236 -169,2019-02-28,-111.12500000000001,48.325,0.968996945881318 -169,2019-03-01,-111.12500000000001,48.325,0.9689954919427124 -169,2019-03-02,-111.12500000000001,48.325,0.9689938670913708 -169,2019-03-03,-111.12500000000001,48.325,0.9689922422400292 -169,2019-03-04,-111.12500000000001,48.325,0.9689906173886877 -169,2019-03-05,-111.12500000000001,48.325,0.9689889925373462 -169,2019-03-06,-111.12500000000001,48.325,0.9689873676860046 -169,2019-03-07,-111.12500000000001,48.325,0.968985742834663 -169,2019-03-08,-111.12500000000001,48.325,0.9689841179833214 -169,2019-03-09,-111.12500000000001,48.325,0.9689824931319798 -169,2019-03-10,-111.12500000000001,48.325,0.9689808682806382 -169,2019-03-11,-111.12500000000001,48.325,0.9689792434292968 -169,2019-03-12,-111.12500000000001,48.325,0.9689776185779552 -169,2019-03-13,-111.12500000000001,48.325,0.9689759937266136 -169,2019-03-14,-111.12500000000001,48.325,0.968974368875272 -169,2019-03-15,-111.12500000000001,48.325,0.9689727440239304 -169,2019-03-16,-111.12500000000001,48.325,0.9689711191725888 -169,2019-03-17,-111.12500000000001,48.325,0.9689694943212472 -169,2019-03-18,-111.12500000000001,48.325,0.9689678694699058 -169,2019-03-19,-111.12500000000001,48.325,0.9689662446185642 -169,2019-03-20,-111.12500000000001,48.325,0.9689646197672226 -169,2019-03-21,-111.12500000000001,48.325,0.968962994915881 -169,2019-03-22,-111.12500000000001,48.325,0.9689613700645394 -169,2019-03-23,-111.12500000000001,48.325,0.9689597452131978 -169,2019-03-24,-111.12500000000001,48.325,0.9689581203618562 -169,2019-03-25,-111.12500000000001,48.325,0.9689564955105147 -169,2019-03-26,-111.12500000000001,48.325,0.9689548706591732 -169,2019-03-27,-111.12500000000001,48.325,0.9689532458078316 -169,2019-03-28,-111.12500000000001,48.325,0.96895162095649 -169,2019-03-29,-111.12500000000001,48.325,0.9689499961051484 -169,2019-03-30,-111.12500000000001,48.325,0.9689483712538068 -169,2019-03-31,-111.12500000000001,48.325,0.9689467464024653 -169,2019-04-01,-111.12500000000001,48.325,0.9689451215511237 -169,2019-04-02,-111.12500000000001,48.325,0.9689431237026352 -169,2019-04-03,-111.12500000000001,48.325,0.9689411258541467 -169,2019-04-04,-111.12500000000001,48.325,0.9689391280056582 -169,2019-04-05,-111.12500000000001,48.325,0.9689371301571696 -169,2019-04-06,-111.12500000000001,48.325,0.9689351323086811 -169,2019-04-07,-111.12500000000001,48.325,0.9689331344601926 -169,2019-04-08,-111.12500000000001,48.325,0.968931136611704 -169,2019-04-09,-111.12500000000001,48.325,0.9689291387632156 -169,2019-04-10,-111.12500000000001,48.325,0.9689271409147271 -169,2019-04-11,-111.12500000000001,48.325,0.9689251430662386 -169,2019-04-12,-111.12500000000001,48.325,0.96892314521775 -169,2019-04-13,-111.12500000000001,48.325,0.9689211473692615 -169,2019-04-14,-111.12500000000001,48.325,0.968919149520773 -169,2019-04-15,-111.12500000000001,48.325,0.9689171516722844 -169,2019-04-16,-111.12500000000001,48.325,0.968915153823796 -169,2019-04-17,-111.12500000000001,48.325,0.9689131559753075 -169,2019-04-18,-111.12500000000001,48.325,0.9689111581268189 -169,2019-04-19,-111.12500000000001,48.325,0.9689091602783304 -169,2019-04-20,-111.12500000000001,48.325,0.9689071624298419 -169,2019-04-21,-111.12500000000001,48.325,0.9689051645813533 -169,2019-04-22,-111.12500000000001,48.325,0.9689031667328649 -169,2019-04-23,-111.12500000000001,48.325,0.9689011688843764 -169,2019-04-24,-111.12500000000001,48.325,0.9688991710358879 -169,2019-04-25,-111.12500000000001,48.325,0.9688971731873993 -169,2019-04-26,-111.12500000000001,48.325,0.9688951753389108 -169,2019-04-27,-111.12500000000001,48.325,0.9688931774904223 -169,2019-04-28,-111.12500000000001,48.325,0.9688911796419337 -169,2019-04-29,-111.12500000000001,48.325,0.9688891817934453 -169,2019-04-30,-111.12500000000001,48.325,0.9688871839449568 -169,2019-05-01,-111.12500000000001,48.325,0.9688851860964682 -169,2019-05-02,-111.12500000000001,48.325,0.9688831513982936 -169,2019-05-03,-111.12500000000001,48.325,0.9688811167001191 -169,2019-05-04,-111.12500000000001,48.325,0.9688790820019445 -169,2019-05-05,-111.12500000000001,48.325,0.96887704730377 -169,2019-05-06,-111.12500000000001,48.325,0.9688750126055954 -169,2019-05-07,-111.12500000000001,48.325,0.9688729779074208 -169,2019-05-08,-111.12500000000001,48.325,0.9688709432092463 -169,2019-05-09,-111.12500000000001,48.325,0.9688689085110717 -169,2019-05-10,-111.12500000000001,48.325,0.9688668738128972 -169,2019-05-11,-111.12500000000001,48.325,0.9688648391147225 -169,2019-05-12,-111.12500000000001,48.325,0.968862804416548 -169,2019-05-13,-111.12500000000001,48.325,0.9688607697183734 -169,2019-05-14,-111.12500000000001,48.325,0.9688587350201988 -169,2019-05-15,-111.12500000000001,48.325,0.9688567003220243 -169,2019-05-16,-111.12500000000001,48.325,0.9688546656238497 -169,2019-05-17,-111.12500000000001,48.325,0.9688526309256752 -169,2019-05-18,-111.12500000000001,48.325,0.9688505962275006 -169,2019-05-19,-111.12500000000001,48.325,0.9685822700680965 -169,2019-05-20,-111.12500000000001,48.325,0.968384628773688 -169,2019-05-21,-111.12500000000001,48.325,0.968347896445989 -169,2019-05-22,-111.12500000000001,48.325,0.9684196985959641 -169,2019-05-23,-111.12500000000001,48.325,0.9683937677900399 -169,2019-05-24,-111.12500000000001,48.325,0.9681547985754108 -169,2019-05-25,-111.12500000000001,48.325,0.9678164915532573 -169,2019-05-26,-111.12500000000001,48.325,0.9674920094335783 -169,2019-05-27,-111.12500000000001,48.325,0.9672446529107565 -169,2019-05-28,-111.12500000000001,48.325,0.9670883495249958 -169,2019-05-29,-111.12500000000001,48.325,0.9670528218375307 -169,2019-05-30,-111.12500000000001,48.325,0.9672857736669241 -169,2019-05-31,-111.12500000000001,48.325,0.9677053497657355 -169,2019-06-01,-111.12500000000001,48.325,0.9681407853041087 -169,2019-06-02,-111.12500000000001,48.325,0.9685674361693455 -169,2019-06-03,-111.12500000000001,48.325,0.968982904908173 -169,2019-06-04,-111.12500000000001,48.325,0.9694112866677596 -169,2019-06-05,-111.12500000000001,48.325,0.969895213916683 -169,2019-06-06,-111.12500000000001,48.325,0.970452323094357 -169,2019-06-07,-111.12500000000001,48.325,0.9710192607230156 -169,2019-06-08,-111.12500000000001,48.325,0.9715128709340823 -169,2019-06-09,-111.12500000000001,48.325,0.971962862706009 -169,2019-06-10,-111.12500000000001,48.325,0.9723544993617029 -169,2019-06-11,-111.12500000000001,48.325,0.9726692300340337 -169,2019-06-12,-111.12500000000001,48.325,0.9729268005199936 -169,2019-06-13,-111.12500000000001,48.325,0.9730983984287739 -169,2019-06-14,-111.12500000000001,48.325,0.9731841340097932 -169,2019-06-15,-111.12500000000001,48.325,0.9731865203235723 -169,2019-06-16,-111.12500000000001,48.325,0.9731228592891134 -169,2019-06-17,-111.12500000000001,48.325,0.9730041143620448 -169,2019-06-18,-111.12500000000001,48.325,0.9728651018686094 -169,2019-06-19,-111.12500000000001,48.325,0.9727622016535955 -169,2019-06-20,-111.12500000000001,48.325,0.9726438607118516 -169,2019-06-21,-111.12500000000001,48.325,0.9724816611273152 -169,2019-06-22,-111.12500000000001,48.325,0.9723298818786302 -169,2019-06-23,-111.12500000000001,48.325,0.9721296067718187 -169,2019-06-24,-111.12500000000001,48.325,0.9718330034288206 -169,2019-06-25,-111.12500000000001,48.325,0.9714861088787404 -169,2019-06-26,-111.12500000000001,48.325,0.9711235392451008 -169,2019-06-27,-111.12500000000001,48.325,0.9707086134189516 -169,2019-06-28,-111.12500000000001,48.325,0.9702654470019797 -169,2019-06-29,-111.12500000000001,48.325,0.9698189205063664 -169,2019-06-30,-111.12500000000001,48.325,0.9695724858997179 -169,2019-07-01,-111.12500000000001,48.325,0.9695679823932187 -169,2019-07-02,-111.12500000000001,48.325,0.9695652925757005 -169,2019-07-03,-111.12500000000001,48.325,0.9695629618887853 -169,2019-07-04,-111.12500000000001,48.325,0.9695606496563327 -169,2019-07-05,-111.12500000000001,48.325,0.9695583374238802 -169,2019-07-06,-111.12500000000001,48.325,0.9695560251914277 -169,2019-07-07,-111.12500000000001,48.325,0.9695536879663401 -169,2019-07-08,-111.12500000000001,48.325,0.9695512066751915 -169,2019-07-09,-111.12500000000001,48.325,0.9695460120950156 -169,2019-07-10,-111.12500000000001,48.325,0.9695436998625631 -169,2019-07-11,-111.12500000000001,48.325,0.969540465240464 -169,2019-07-12,-111.12500000000001,48.325,0.9695381529167555 -169,2019-07-13,-111.12500000000001,48.325,0.9695261421623711 -169,2019-07-14,-111.12500000000001,48.325,0.96951791681133 -169,2019-07-15,-111.12500000000001,48.325,0.9695125838626151 -169,2019-07-16,-111.12500000000001,48.325,0.9695043159824477 -169,2019-07-17,-111.12500000000001,48.325,0.9695016135186227 -169,2019-07-18,-111.12500000000001,48.325,0.9694992062206605 -169,2019-07-19,-111.12500000000001,48.325,0.9694906137408277 -169,2019-07-20,-111.12500000000001,48.325,0.9694872392206721 -169,2019-07-21,-111.12500000000001,48.325,0.9694847862697611 -169,2019-07-22,-111.12500000000001,48.325,0.9694810749351008 -169,2019-07-23,-111.12500000000001,48.325,0.9694615320931473 -169,2019-07-24,-111.12500000000001,48.325,0.9694303887157921 -169,2019-07-25,-111.12500000000001,48.325,0.9694040758849067 -169,2019-07-26,-111.12500000000001,48.325,0.9693615184980439 -169,2019-07-27,-111.12500000000001,48.325,0.9693384698022711 -169,2019-07-28,-111.12500000000001,48.325,0.9692987010766486 -169,2019-07-29,-111.12500000000001,48.325,0.9692649641935892 -169,2019-07-30,-111.12500000000001,48.325,0.9692282259038746 -169,2019-07-31,-111.12500000000001,48.325,0.9691995720105028 -169,2019-08-01,-111.12500000000001,48.325,0.9691701354224797 -169,2019-08-02,-111.12500000000001,48.325,0.9691384801334811 -169,2019-08-03,-111.12500000000001,48.325,0.9691035238543587 -169,2019-08-04,-111.12500000000001,48.325,0.9690680188854957 -169,2019-08-05,-111.12500000000001,48.325,0.9690366684045232 -169,2019-08-06,-111.12500000000001,48.325,0.9690133236776843 -169,2019-08-07,-111.12500000000001,48.325,0.9689952535290017 -169,2019-08-08,-111.12500000000001,48.325,0.9689807793932332 -169,2019-08-09,-111.12500000000001,48.325,0.9689435258982266 -169,2019-08-10,-111.12500000000001,48.325,0.9689291366944873 -169,2019-08-11,-111.12500000000001,48.325,0.968926815152463 -169,2019-08-12,-111.12500000000001,48.325,0.9689244936104389 -169,2019-08-13,-111.12500000000001,48.325,0.968922129280573 -169,2019-08-14,-111.12500000000001,48.325,0.9689197203515381 -169,2019-08-15,-111.12500000000001,48.325,0.9689139913933107 -169,2019-08-16,-111.12500000000001,48.325,0.9688864966610587 -169,2019-08-17,-111.12500000000001,48.325,0.968863525214859 -169,2019-08-18,-111.12500000000001,48.325,0.9688612036728348 -169,2019-08-19,-111.12500000000001,48.325,0.9688549568876063 -169,2019-08-20,-111.12500000000001,48.325,0.9688477257416006 -169,2019-08-21,-111.12500000000001,48.325,0.9688427169066621 -169,2019-08-22,-111.12500000000001,48.325,0.9688333575307242 -169,2019-08-23,-111.12500000000001,48.325,0.9688305098882481 -169,2019-08-24,-111.12500000000001,48.325,0.9688281878371926 -169,2019-08-25,-111.12500000000001,48.325,0.9688245503000071 -169,2019-08-26,-111.12500000000001,48.325,0.96881739307198 -169,2019-08-27,-111.12500000000001,48.325,0.9688150597449969 -169,2019-08-28,-111.12500000000001,48.325,0.9688127382027616 -169,2019-08-29,-111.12500000000001,48.325,0.9688041131615804 -169,2019-08-30,-111.12500000000001,48.325,0.9688017916195563 -169,2019-08-31,-111.12500000000001,48.325,0.9687994699704067 -169,2019-09-01,-111.12500000000001,48.325,0.968780165505064 -169,2019-09-02,-111.12500000000001,48.325,0.9687777269017749 -169,2019-09-03,-111.12500000000001,48.325,0.9687647076067567 -169,2019-09-04,-111.12500000000001,48.325,0.9687571235422171 -169,2019-09-05,-111.12500000000001,48.325,0.9687440665146348 -169,2019-09-06,-111.12500000000001,48.325,0.9687286419479051 -169,2019-09-07,-111.12500000000001,48.325,0.9687263911570957 -169,2019-09-08,-111.12500000000001,48.325,0.9687241460911923 -169,2019-09-09,-111.12500000000001,48.325,0.9687219010252888 -169,2019-09-10,-111.12500000000001,48.325,0.9687196559593854 -169,2019-09-11,-111.12500000000001,48.325,0.9687174108934818 -169,2019-09-12,-111.12500000000001,48.325,0.9687151658275784 -169,2019-09-13,-111.12500000000001,48.325,0.9687129207616749 -169,2019-09-14,-111.12500000000001,48.325,0.9687106756957715 -169,2019-09-15,-111.12500000000001,48.325,0.968708430629868 -169,2019-09-16,-111.12500000000001,48.325,0.9687041900682696 -169,2019-09-17,-111.12500000000001,48.325,0.9687019448126141 -169,2019-09-18,-111.12500000000001,48.325,0.9686996997467106 -169,2019-09-19,-111.12500000000001,48.325,0.9686974546808071 -169,2019-09-20,-111.12500000000001,48.325,0.9686952096149036 -169,2019-09-21,-111.12500000000001,48.325,0.9686929645490002 -169,2019-09-22,-111.12500000000001,48.325,0.9686907194830967 -169,2019-09-23,-111.12500000000001,48.325,0.9686884714757479 -169,2019-09-24,-111.12500000000001,48.325,0.9686862225473623 -169,2019-09-25,-111.12500000000001,48.325,0.96868276682026 -169,2019-09-26,-111.12500000000001,48.325,0.9686803558769046 -169,2019-09-27,-111.12500000000001,48.325,0.9686781108110012 -169,2019-09-28,-111.12500000000001,48.325,0.9686758657450977 -169,2019-09-29,-111.12500000000001,48.325,0.9686736206791943 -169,2019-09-30,-111.12500000000001,48.325,0.9686713756132908 -169,2019-10-01,-111.12500000000001,48.325,0.9686691305473873 -169,2019-10-02,-111.12500000000001,48.325,0.9686673074758938 -169,2019-10-03,-111.12500000000001,48.325,0.9686654844044003 -169,2019-10-04,-111.12500000000001,48.325,0.9686636613329067 -169,2019-10-05,-111.12500000000001,48.325,0.9686618382614132 -169,2019-10-06,-111.12500000000001,48.325,0.9686600151899196 -169,2019-10-07,-111.12500000000001,48.325,0.9686581921184261 -169,2019-10-08,-111.12500000000001,48.325,0.9686563690469325 -169,2019-10-09,-111.12500000000001,48.325,0.968654545975439 -169,2019-10-10,-111.12500000000001,48.325,0.9686527229039454 -169,2019-10-11,-111.12500000000001,48.325,0.9686508998324519 -169,2019-10-12,-111.12500000000001,48.325,0.9686490767609585 -169,2019-10-13,-111.12500000000001,48.325,0.9686472536894649 -169,2019-10-14,-111.12500000000001,48.325,0.9686454306179714 -169,2019-10-15,-111.12500000000001,48.325,0.9686436075464778 -169,2019-10-16,-111.12500000000001,48.325,0.9686417844749843 -169,2019-10-17,-111.12500000000001,48.325,0.9686399614034907 -169,2019-10-18,-111.12500000000001,48.325,0.9686381383319972 -169,2019-10-19,-111.12500000000001,48.325,0.9686363152605036 -169,2019-10-20,-111.12500000000001,48.325,0.9686344921890101 -169,2019-10-21,-111.12500000000001,48.325,0.9686326691175166 -169,2019-10-22,-111.12500000000001,48.325,0.968630846046023 -169,2019-10-23,-111.12500000000001,48.325,0.9686290229745295 -169,2019-10-24,-111.12500000000001,48.325,0.9686271999030359 -169,2019-10-25,-111.12500000000001,48.325,0.9686253768315425 -169,2019-10-26,-111.12500000000001,48.325,0.9686235537600489 -169,2019-10-27,-111.12500000000001,48.325,0.9686217306885554 -169,2019-10-28,-111.12500000000001,48.325,0.9686199076170618 -169,2019-10-29,-111.12500000000001,48.325,0.9686180845455683 -169,2019-10-30,-111.12500000000001,48.325,0.9686162614740748 -169,2019-10-31,-111.12500000000001,48.325,0.9686144384025812 -169,2019-11-01,-111.12500000000001,48.325,0.9686126153310877 -169,2019-11-02,-111.12500000000001,48.325,0.9686107967435671 -169,2019-11-03,-111.12500000000001,48.325,0.9686089781560465 -169,2019-11-04,-111.12500000000001,48.325,0.9686071595685259 -169,2019-11-05,-111.12500000000001,48.325,0.9686053409810054 -169,2019-11-06,-111.12500000000001,48.325,0.9686035223934848 -169,2019-11-07,-111.12500000000001,48.325,0.9686017038059643 -169,2019-11-08,-111.12500000000001,48.325,0.9685998852184438 -169,2019-11-09,-111.12500000000001,48.325,0.9685980666309232 -169,2019-11-10,-111.12500000000001,48.325,0.9685962480434026 -169,2019-11-11,-111.12500000000001,48.325,0.968594429455882 -169,2019-11-12,-111.12500000000001,48.325,0.9685926108683615 -169,2019-11-13,-111.12500000000001,48.325,0.9685907922808409 -169,2019-11-14,-111.12500000000001,48.325,0.9685889736933203 -169,2019-11-15,-111.12500000000001,48.325,0.9685871551057997 -169,2019-11-16,-111.12500000000001,48.325,0.9685853365182792 -169,2019-11-17,-111.12500000000001,48.325,0.9685835179307586 -169,2019-11-18,-111.12500000000001,48.325,0.968581699343238 -169,2019-11-19,-111.12500000000001,48.325,0.9685798807557174 -169,2019-11-20,-111.12500000000001,48.325,0.9685780621681969 -169,2019-11-21,-111.12500000000001,48.325,0.9685762435806763 -169,2019-11-22,-111.12500000000001,48.325,0.9685744249931558 -169,2019-11-23,-111.12500000000001,48.325,0.9685726064056353 -169,2019-11-24,-111.12500000000001,48.325,0.9685707878181147 -169,2019-11-25,-111.12500000000001,48.325,0.9685689692305941 -169,2019-11-26,-111.12500000000001,48.325,0.9685671506430735 -169,2019-11-27,-111.12500000000001,48.325,0.968565332055553 -169,2019-11-28,-111.12500000000001,48.325,0.9685635134680324 -169,2019-11-29,-111.12500000000001,48.325,0.9685616948805118 -169,2019-11-30,-111.12500000000001,48.325,0.9685598762929912 -169,2019-12-01,-111.12500000000001,48.325,0.9685580577054707 -169,2019-12-02,-111.12500000000001,48.325,0.9685563368344328 -169,2019-12-03,-111.12500000000001,48.325,0.9685546159633948 -169,2019-12-04,-111.12500000000001,48.325,0.9685528950923568 -169,2019-12-05,-111.12500000000001,48.325,0.9685511742213189 -169,2019-12-06,-111.12500000000001,48.325,0.9685494533502809 -169,2019-12-07,-111.12500000000001,48.325,0.968547732479243 -169,2019-12-08,-111.12500000000001,48.325,0.968546011608205 -169,2019-12-09,-111.12500000000001,48.325,0.9685442907371671 -169,2019-12-10,-111.12500000000001,48.325,0.9685425698661291 -169,2019-12-11,-111.12500000000001,48.325,0.9685408489950912 -169,2019-12-12,-111.12500000000001,48.325,0.9685391281240532 -169,2019-12-13,-111.12500000000001,48.325,0.9685374072530153 -169,2019-12-14,-111.12500000000001,48.325,0.9685356863819773 -169,2019-12-15,-111.12500000000001,48.325,0.9685339655109393 -169,2019-12-16,-111.12500000000001,48.325,0.9685322446399014 -169,2019-12-17,-111.12500000000001,48.325,0.9685305237688634 -169,2019-12-18,-111.12500000000001,48.325,0.9685288028978255 -169,2019-12-19,-111.12500000000001,48.325,0.9685270820267875 -169,2019-12-20,-111.12500000000001,48.325,0.9685253611557496 -169,2019-12-21,-111.12500000000001,48.325,0.9685236402847116 -169,2019-12-22,-111.12500000000001,48.325,0.9685219194136737 -169,2019-12-23,-111.12500000000001,48.325,0.9685201985426357 -169,2019-12-24,-111.12500000000001,48.325,0.9685184776715978 -169,2019-12-25,-111.12500000000001,48.325,0.9685167568005598 -169,2019-12-26,-111.12500000000001,48.325,0.9685150359295218 -169,2019-12-27,-111.12500000000001,48.325,0.9685133150584839 -169,2019-12-28,-111.12500000000001,48.325,0.9685115941874459 -169,2019-12-29,-111.12500000000001,48.325,0.968509873316408 -169,2019-12-30,-111.12500000000001,48.325,0.96850815244537 -169,2019-12-31,-111.12500000000001,48.325,0.9685064315743321 -169,2020-01-01,-111.12500000000001,48.325,0.9685047107032941 -227,2018-01-02,-107.97500000000001,45.325,0.9416456605327589 -227,2018-01-03,-107.97500000000001,45.325,0.9415769158458996 -227,2018-01-04,-107.97500000000001,45.325,0.9415404403419912 -227,2018-01-05,-107.97500000000001,45.325,0.9415395175986124 -227,2018-01-06,-107.97500000000001,45.325,0.9415471558871094 -227,2018-01-07,-107.97500000000001,45.325,0.9415503266719905 -227,2018-01-08,-107.97500000000001,45.325,0.9415162295989233 -227,2018-01-09,-107.97500000000001,45.325,0.9414470560462368 -227,2018-01-10,-107.97500000000001,45.325,0.94139329660236 -227,2018-01-11,-107.97500000000001,45.325,0.9413604333285712 -227,2018-01-12,-107.97500000000001,45.325,0.9413546051021173 -227,2018-01-13,-107.97500000000001,45.325,0.9413818356760262 -227,2018-01-14,-107.97500000000001,45.325,0.9414103432352463 -227,2018-01-15,-107.97500000000001,45.325,0.9414347738557651 -227,2018-01-16,-107.97500000000001,45.325,0.9414506866909111 -227,2018-01-17,-107.97500000000001,45.325,0.9414381868106995 -227,2018-01-18,-107.97500000000001,45.325,0.9413784752527662 -227,2018-01-19,-107.97500000000001,45.325,0.9413046440368856 -227,2018-01-20,-107.97500000000001,45.325,0.9412884703370231 -227,2018-01-21,-107.97500000000001,45.325,0.9412903080904974 -227,2018-01-22,-107.97500000000001,45.325,0.9414126861390109 -227,2018-01-23,-107.97500000000001,45.325,0.9417725161998963 -227,2018-01-24,-107.97500000000001,45.325,0.9421783326891382 -227,2018-01-25,-107.97500000000001,45.325,0.9422899643377532 -227,2018-01-26,-107.97500000000001,45.325,0.9421324958753021 -227,2018-01-27,-107.97500000000001,45.325,0.9418518303564559 -227,2018-01-28,-107.97500000000001,45.325,0.94154124186131 -227,2018-01-29,-107.97500000000001,45.325,0.9412419928649637 -227,2018-01-30,-107.97500000000001,45.325,0.9409640064574012 -227,2018-01-31,-107.97500000000001,45.325,0.9407913001350233 -227,2018-02-01,-107.97500000000001,45.325,0.9407022852605745 -227,2018-02-02,-107.97500000000001,45.325,0.940713706245489 -227,2018-02-03,-107.97500000000001,45.325,0.9408947119926786 -227,2018-02-04,-107.97500000000001,45.325,0.9411430398873056 -227,2018-02-05,-107.97500000000001,45.325,0.9413034068132841 -227,2018-02-06,-107.97500000000001,45.325,0.941364821638108 -227,2018-02-07,-107.97500000000001,45.325,0.9412898500685001 -227,2018-02-08,-107.97500000000001,45.325,0.9411324129368844 -227,2018-02-09,-107.97500000000001,45.325,0.940992396284389 -227,2018-02-10,-107.97500000000001,45.325,0.9410438597143029 -227,2018-02-11,-107.97500000000001,45.325,0.9412832384205974 -227,2018-02-12,-107.97500000000001,45.325,0.9415064126310669 -227,2018-02-13,-107.97500000000001,45.325,0.941644734241454 -227,2018-02-14,-107.97500000000001,45.325,0.9416171270334427 -227,2018-02-15,-107.97500000000001,45.325,0.9414578582610518 -227,2018-02-16,-107.97500000000001,45.325,0.9412243287109892 -227,2018-02-17,-107.97500000000001,45.325,0.9409528009229309 -227,2018-02-18,-107.97500000000001,45.325,0.9406636846505544 -227,2018-02-19,-107.97500000000001,45.325,0.9403847594058391 -227,2018-02-20,-107.97500000000001,45.325,0.940133554204784 -227,2018-02-21,-107.97500000000001,45.325,0.9399116281694777 -227,2018-02-22,-107.97500000000001,45.325,0.939723351411266 -227,2018-02-23,-107.97500000000001,45.325,0.9395846105157218 -227,2018-02-24,-107.97500000000001,45.325,0.9395214904352878 -227,2018-02-25,-107.97500000000001,45.325,0.9395205762686125 -227,2018-02-26,-107.97500000000001,45.325,0.9395171157699527 -227,2018-02-27,-107.97500000000001,45.325,0.9394680723340081 -227,2018-02-28,-107.97500000000001,45.325,0.9393673553518532 -227,2018-03-01,-107.97500000000001,45.325,0.9392326954501401 -227,2018-03-02,-107.97500000000001,45.325,0.9390853869416212 -227,2018-03-03,-107.97500000000001,45.325,0.9389509092483826 -227,2018-03-04,-107.97500000000001,45.325,0.9388741817649678 -227,2018-03-05,-107.97500000000001,45.325,0.9389812600891098 -227,2018-03-06,-107.97500000000001,45.325,0.9394012354159028 -227,2018-03-07,-107.97500000000001,45.325,0.9400295249394156 -227,2018-03-08,-107.97500000000001,45.325,0.9404086561835113 -227,2018-03-09,-107.97500000000001,45.325,0.9403630503988127 -227,2018-03-10,-107.97500000000001,45.325,0.9400982359898163 -227,2018-03-11,-107.97500000000001,45.325,0.9398107191663968 -227,2018-03-12,-107.97500000000001,45.325,0.9396079763991875 -227,2018-03-13,-107.97500000000001,45.325,0.9395877257771321 -227,2018-03-14,-107.97500000000001,45.325,0.9397278274214648 -227,2018-03-15,-107.97500000000001,45.325,0.9398726711110679 -227,2018-03-16,-107.97500000000001,45.325,0.9400247641793213 -227,2018-03-17,-107.97500000000001,45.325,0.9403009130755103 -227,2018-03-18,-107.97500000000001,45.325,0.9409087996331655 -227,2018-03-19,-107.97500000000001,45.325,0.9419864825508977 -227,2018-03-20,-107.97500000000001,45.325,0.9431997708382622 -227,2018-03-21,-107.97500000000001,45.325,0.9439043350875842 -227,2018-03-22,-107.97500000000001,45.325,0.9440273692891548 -227,2018-03-23,-107.97500000000001,45.325,0.9437853458330129 -227,2018-03-24,-107.97500000000001,45.325,0.9434494481224255 -227,2018-03-25,-107.97500000000001,45.325,0.9432619312945161 -227,2018-03-26,-107.97500000000001,45.325,0.9435321550568373 -227,2018-03-27,-107.97500000000001,45.325,0.9440504616194538 -227,2018-03-28,-107.97500000000001,45.325,0.9445873704060017 -227,2018-03-29,-107.97500000000001,45.325,0.9451033302736773 -227,2018-03-30,-107.97500000000001,45.325,0.9457024287309334 -227,2018-03-31,-107.97500000000001,45.325,0.9458970147164016 -227,2018-04-01,-107.97500000000001,45.325,0.9456617660838398 -227,2018-04-02,-107.97500000000001,45.325,0.945129378037772 -227,2018-04-03,-107.97500000000001,45.325,0.9443763839248075 -227,2018-04-04,-107.97500000000001,45.325,0.9443757237453734 -227,2018-04-05,-107.97500000000001,45.325,0.9443750635659393 -227,2018-04-06,-107.97500000000001,45.325,0.9443744033865051 -227,2018-04-07,-107.97500000000001,45.325,0.944373743207071 -227,2018-04-08,-107.97500000000001,45.325,0.9443730830276368 -227,2018-04-09,-107.97500000000001,45.325,0.9437719832348829 -227,2018-04-10,-107.97500000000001,45.325,0.9433467068810055 -227,2018-04-11,-107.97500000000001,45.325,0.9434395028158377 -227,2018-04-12,-107.97500000000001,45.325,0.9442878043010929 -227,2018-04-13,-107.97500000000001,45.325,0.9454106643359519 -227,2018-04-14,-107.97500000000001,45.325,0.9464277790744062 -227,2018-04-15,-107.97500000000001,45.325,0.9475667714213207 -227,2018-04-16,-107.97500000000001,45.325,0.9484759598362563 -227,2018-04-17,-107.97500000000001,45.325,0.9487571824958345 -227,2018-04-18,-107.97500000000001,45.325,0.9485188722800945 -227,2018-04-19,-107.97500000000001,45.325,0.948411706952266 -227,2018-04-20,-107.97500000000001,45.325,0.9489426485035848 -227,2018-04-21,-107.97500000000001,45.325,0.9499965238416372 -227,2018-04-22,-107.97500000000001,45.325,0.9503405863029002 -227,2018-04-23,-107.97500000000001,45.325,0.9498586576062267 -227,2018-04-24,-107.97500000000001,45.325,0.9493868377899557 -227,2018-04-25,-107.97500000000001,45.325,0.9492667546766236 -227,2018-04-26,-107.97500000000001,45.325,0.9494679394387932 -227,2018-04-27,-107.97500000000001,45.325,0.9496564987094493 -227,2018-04-28,-107.97500000000001,45.325,0.9494615100262034 -227,2018-04-29,-107.97500000000001,45.325,0.9489946247489729 -227,2018-04-30,-107.97500000000001,45.325,0.9488143326402317 -227,2018-05-01,-107.97500000000001,45.325,0.9496004540824491 -227,2018-05-02,-107.97500000000001,45.325,0.9515824313184049 -227,2018-05-03,-107.97500000000001,45.325,0.9548083316108124 -227,2018-05-04,-107.97500000000001,45.325,0.9596555996448372 -227,2018-05-05,-107.97500000000001,45.325,0.9636419770915242 -227,2018-05-06,-107.97500000000001,45.325,0.965355088954854 -227,2018-05-07,-107.97500000000001,45.325,0.965840540882311 -227,2018-05-08,-107.97500000000001,45.325,0.965981617054919 -227,2018-05-09,-107.97500000000001,45.325,0.9661431354559025 -227,2018-05-10,-107.97500000000001,45.325,0.9668717971237639 -227,2018-05-11,-107.97500000000001,45.325,0.9679923036548658 -227,2018-05-12,-107.97500000000001,45.325,0.9698095450739258 -227,2018-05-13,-107.97500000000001,45.325,0.9724130781852465 -227,2018-05-14,-107.97500000000001,45.325,0.9755567146970278 -227,2018-05-15,-107.97500000000001,45.325,0.9811779595715315 -227,2018-05-16,-107.97500000000001,45.325,0.9872190456584843 -227,2018-05-17,-107.97500000000001,45.325,0.9907286639426492 -227,2018-05-18,-107.97500000000001,45.325,0.991180465998462 -227,2018-05-19,-107.97500000000001,45.325,0.9911991920467857 -227,2018-05-20,-107.97500000000001,45.325,0.9917117819044878 -227,2018-05-21,-107.97500000000001,45.325,0.9925608650596234 -227,2018-05-22,-107.97500000000001,45.325,0.9934704246268076 -227,2018-05-23,-107.97500000000001,45.325,0.994265012407088 -227,2018-05-24,-107.97500000000001,45.325,0.9952922636531325 -227,2018-05-25,-107.97500000000001,45.325,0.9971887344802519 -227,2018-05-26,-107.97500000000001,45.325,1.0 -227,2018-05-27,-107.97500000000001,45.325,1.0 -227,2018-05-28,-107.97500000000001,45.325,1.0 -227,2018-05-29,-107.97500000000001,45.325,1.0 -227,2018-05-30,-107.97500000000001,45.325,1.0 -227,2018-05-31,-107.97500000000001,45.325,1.0 -227,2018-06-01,-107.97500000000001,45.325,1.0 -227,2018-06-02,-107.97500000000001,45.325,1.0 -227,2018-06-03,-107.97500000000001,45.325,1.0 -227,2018-06-04,-107.97500000000001,45.325,1.0 -227,2018-06-05,-107.97500000000001,45.325,1.0 -227,2018-06-06,-107.97500000000001,45.325,1.0 -227,2018-06-07,-107.97500000000001,45.325,1.0 -227,2018-06-08,-107.97500000000001,45.325,1.0 -227,2018-06-09,-107.97500000000001,45.325,1.0 -227,2018-06-10,-107.97500000000001,45.325,1.0 -227,2018-06-11,-107.97500000000001,45.325,1.0 -227,2018-06-12,-107.97500000000001,45.325,1.0 -227,2018-06-13,-107.97500000000001,45.325,1.0 -227,2018-06-14,-107.97500000000001,45.325,1.0 -227,2018-06-15,-107.97500000000001,45.325,1.0 -227,2018-06-16,-107.97500000000001,45.325,1.0 -227,2018-06-17,-107.97500000000001,45.325,1.0 -227,2018-06-18,-107.97500000000001,45.325,1.0 -227,2018-06-19,-107.97500000000001,45.325,1.0 -227,2018-06-20,-107.97500000000001,45.325,1.0 -227,2018-06-21,-107.97500000000001,45.325,1.0 -227,2018-06-22,-107.97500000000001,45.325,1.0 -227,2018-06-23,-107.97500000000001,45.325,1.0 -227,2018-06-24,-107.97500000000001,45.325,1.0 -227,2018-06-25,-107.97500000000001,45.325,1.0 -227,2018-06-26,-107.97500000000001,45.325,1.0 -227,2018-06-27,-107.97500000000001,45.325,1.0 -227,2018-06-28,-107.97500000000001,45.325,1.0 -227,2018-06-29,-107.97500000000001,45.325,1.0 -227,2018-06-30,-107.97500000000001,45.325,1.0 -227,2018-07-01,-107.97500000000001,45.325,1.0 -227,2018-07-02,-107.97500000000001,45.325,1.0 -227,2018-07-03,-107.97500000000001,45.325,1.0 -227,2018-07-04,-107.97500000000001,45.325,1.0 -227,2018-07-05,-107.97500000000001,45.325,1.0 -227,2018-07-06,-107.97500000000001,45.325,0.9998854966196362 -227,2018-07-07,-107.97500000000001,45.325,0.9992366066925761 -227,2018-07-08,-107.97500000000001,45.325,0.9985269730396262 -227,2018-07-09,-107.97500000000001,45.325,0.9978792296481829 -227,2018-07-10,-107.97500000000001,45.325,0.997261057189504 -227,2018-07-11,-107.97500000000001,45.325,0.9967281895247544 -227,2018-07-12,-107.97500000000001,45.325,0.9961786129025745 -227,2018-07-13,-107.97500000000001,45.325,0.9956503270759961 -227,2018-07-14,-107.97500000000001,45.325,0.9951661006152379 -227,2018-07-15,-107.97500000000001,45.325,0.9947491517838808 -227,2018-07-16,-107.97500000000001,45.325,0.9943591732660454 -227,2018-07-17,-107.97500000000001,45.325,0.9939016226688343 -227,2018-07-18,-107.97500000000001,45.325,0.9934372331224727 -227,2018-07-19,-107.97500000000001,45.325,0.9931247050543389 -227,2018-07-20,-107.97500000000001,45.325,0.9929623046028853 -227,2018-07-21,-107.97500000000001,45.325,0.9926361700568246 -227,2018-07-22,-107.97500000000001,45.325,0.9921719624396329 -227,2018-07-23,-107.97500000000001,45.325,0.9916571020750363 -227,2018-07-24,-107.97500000000001,45.325,0.9911742099905583 -227,2018-07-25,-107.97500000000001,45.325,0.9907703629395083 -227,2018-07-26,-107.97500000000001,45.325,0.9904256714183194 -227,2018-07-27,-107.97500000000001,45.325,0.9901229632127788 -227,2018-07-28,-107.97500000000001,45.325,0.989936425059555 -227,2018-07-29,-107.97500000000001,45.325,0.9900015478549017 -227,2018-07-30,-107.97500000000001,45.325,0.990196208344029 -227,2018-07-31,-107.97500000000001,45.325,0.9902094500282381 -227,2018-08-01,-107.97500000000001,45.325,0.9901249968257555 -227,2018-08-02,-107.97500000000001,45.325,0.9899684157133282 -227,2018-08-03,-107.97500000000001,45.325,0.9894057022739697 -227,2018-08-04,-107.97500000000001,45.325,0.9883746901255617 -227,2018-08-05,-107.97500000000001,45.325,0.9870999011851848 -227,2018-08-06,-107.97500000000001,45.325,0.9856333153898768 -227,2018-08-07,-107.97500000000001,45.325,0.9840084634848829 -227,2018-08-08,-107.97500000000001,45.325,0.9823493374803486 -227,2018-08-09,-107.97500000000001,45.325,0.9807587256432901 -227,2018-08-10,-107.97500000000001,45.325,0.9789237563849573 -227,2018-08-11,-107.97500000000001,45.325,0.9769837199382343 -227,2018-08-12,-107.97500000000001,45.325,0.9751292577414981 -227,2018-08-13,-107.97500000000001,45.325,0.9733549944598924 -227,2018-08-14,-107.97500000000001,45.325,0.9716409664309804 -227,2018-08-15,-107.97500000000001,45.325,0.9699636385367891 -227,2018-08-16,-107.97500000000001,45.325,0.9685824690126708 -227,2018-08-17,-107.97500000000001,45.325,0.9685792581378674 -227,2018-08-18,-107.97500000000001,45.325,0.968575709855854 -227,2018-08-19,-107.97500000000001,45.325,0.9685748623208741 -227,2018-08-20,-107.97500000000001,45.325,0.9685737416681421 -227,2018-08-21,-107.97500000000001,45.325,0.9685728941331622 -227,2018-08-22,-107.97500000000001,45.325,0.9685720465981822 -227,2018-08-23,-107.97500000000001,45.325,0.9685711868345781 -227,2018-08-24,-107.97500000000001,45.325,0.9685702972453617 -227,2018-08-25,-107.97500000000001,45.325,0.9685686564495927 -227,2018-08-26,-107.97500000000001,45.325,0.9685673613015429 -227,2018-08-27,-107.97500000000001,45.325,0.9685664573494385 -227,2018-08-28,-107.97500000000001,45.325,0.9685656098144585 -227,2018-08-29,-107.97500000000001,45.325,0.968564664132933 -227,2018-08-30,-107.97500000000001,45.325,0.9685635616843923 -227,2018-08-31,-107.97500000000001,45.325,0.9685607868464882 -227,2018-09-01,-107.97500000000001,45.325,0.9685598064836861 -227,2018-09-02,-107.97500000000001,45.325,0.9685589520725254 -227,2018-09-03,-107.97500000000001,45.325,0.968556621532929 -227,2018-09-04,-107.97500000000001,45.325,0.9685538777966397 -227,2018-09-05,-107.97500000000001,45.325,0.9685515171589513 -227,2018-09-06,-107.97500000000001,45.325,0.9685506107761279 -227,2018-09-07,-107.97500000000001,45.325,0.9685492275568636 -227,2018-09-08,-107.97500000000001,45.325,0.9685468571258773 -227,2018-09-09,-107.97500000000001,45.325,0.968545663240746 -227,2018-09-10,-107.97500000000001,45.325,0.9685438544309442 -227,2018-09-11,-107.97500000000001,45.325,0.9685421204155046 -227,2018-09-12,-107.97500000000001,45.325,0.9685410329333592 -227,2018-09-13,-107.97500000000001,45.325,0.9685401283993423 -227,2018-09-14,-107.97500000000001,45.325,0.9685387962574261 -227,2018-09-15,-107.97500000000001,45.325,0.9685371795974699 -227,2018-09-16,-107.97500000000001,45.325,0.9685361222793681 -227,2018-09-17,-107.97500000000001,45.325,0.9685350412316727 -227,2018-09-18,-107.97500000000001,45.325,0.9685340126058785 -227,2018-09-19,-107.97500000000001,45.325,0.9685331765103845 -227,2018-09-20,-107.97500000000001,45.325,0.9685323708020727 -227,2018-09-21,-107.97500000000001,45.325,0.9685315650937609 -227,2018-09-22,-107.97500000000001,45.325,0.9685307593854491 -227,2018-09-23,-107.97500000000001,45.325,0.9685296028897358 -227,2018-09-24,-107.97500000000001,45.325,0.968528797181424 -227,2018-09-25,-107.97500000000001,45.325,0.9685279914731122 -227,2018-09-26,-107.97500000000001,45.325,0.9685271857648005 -227,2018-09-27,-107.97500000000001,45.325,0.9685263800564887 -227,2018-09-28,-107.97500000000001,45.325,0.9685255743481769 -227,2018-09-29,-107.97500000000001,45.325,0.9685247686398651 -227,2018-09-30,-107.97500000000001,45.325,0.9685239629315533 -227,2018-10-01,-107.97500000000001,45.325,0.9685231572232416 -227,2018-10-02,-107.97500000000001,45.325,0.9685225021565484 -227,2018-10-03,-107.97500000000001,45.325,0.9685218470898552 -227,2018-10-04,-107.97500000000001,45.325,0.968521192023162 -227,2018-10-05,-107.97500000000001,45.325,0.9685205369564689 -227,2018-10-06,-107.97500000000001,45.325,0.9685198818897757 -227,2018-10-07,-107.97500000000001,45.325,0.9685192268230826 -227,2018-10-08,-107.97500000000001,45.325,0.9685185717563893 -227,2018-10-09,-107.97500000000001,45.325,0.9685179166896962 -227,2018-10-10,-107.97500000000001,45.325,0.968517261623003 -227,2018-10-11,-107.97500000000001,45.325,0.9685166065563098 -227,2018-10-12,-107.97500000000001,45.325,0.9685159514896167 -227,2018-10-13,-107.97500000000001,45.325,0.9685152964229234 -227,2018-10-14,-107.97500000000001,45.325,0.9685146413562303 -227,2018-10-15,-107.97500000000001,45.325,0.9685139862895371 -227,2018-10-16,-107.97500000000001,45.325,0.968513331222844 -227,2018-10-17,-107.97500000000001,45.325,0.9685126761561508 -227,2018-10-18,-107.97500000000001,45.325,0.9685120210894576 -227,2018-10-19,-107.97500000000001,45.325,0.9685113660227644 -227,2018-10-20,-107.97500000000001,45.325,0.9685107109560712 -227,2018-10-21,-107.97500000000001,45.325,0.9685100558893781 -227,2018-10-22,-107.97500000000001,45.325,0.9685094008226849 -227,2018-10-23,-107.97500000000001,45.325,0.9685087457559918 -227,2018-10-24,-107.97500000000001,45.325,0.9685080906892986 -227,2018-10-25,-107.97500000000001,45.325,0.9685074356226053 -227,2018-10-26,-107.97500000000001,45.325,0.9685067805559122 -227,2018-10-27,-107.97500000000001,45.325,0.968506125489219 -227,2018-10-28,-107.97500000000001,45.325,0.9685054704225259 -227,2018-10-29,-107.97500000000001,45.325,0.9685048153558327 -227,2018-10-30,-107.97500000000001,45.325,0.9685041602891395 -227,2018-10-31,-107.97500000000001,45.325,0.9685035052224463 -227,2018-11-01,-107.97500000000001,45.325,0.9685028501557531 -227,2018-11-02,-107.97500000000001,45.325,0.9685022409764974 -227,2018-11-03,-107.97500000000001,45.325,0.9685016317972417 -227,2018-11-04,-107.97500000000001,45.325,0.9685010226179859 -227,2018-11-05,-107.97500000000001,45.325,0.9685004134387302 -227,2018-11-06,-107.97500000000001,45.325,0.9684998042594744 -227,2018-11-07,-107.97500000000001,45.325,0.9684991950802186 -227,2018-11-08,-107.97500000000001,45.325,0.9684985859009628 -227,2018-11-09,-107.97500000000001,45.325,0.9684979767217071 -227,2018-11-10,-107.97500000000001,45.325,0.9684973675424514 -227,2018-11-11,-107.97500000000001,45.325,0.9684967583631956 -227,2018-11-12,-107.97500000000001,45.325,0.9684961491839399 -227,2018-11-13,-107.97500000000001,45.325,0.9684955400046841 -227,2018-11-14,-107.97500000000001,45.325,0.9684949308254284 -227,2018-11-15,-107.97500000000001,45.325,0.9684943216461726 -227,2018-11-16,-107.97500000000001,45.325,0.9684937124669168 -227,2018-11-17,-107.97500000000001,45.325,0.968493103287661 -227,2018-11-18,-107.97500000000001,45.325,0.9684924941084053 -227,2018-11-19,-107.97500000000001,45.325,0.9684918849291496 -227,2018-11-20,-107.97500000000001,45.325,0.9684912757498938 -227,2018-11-21,-107.97500000000001,45.325,0.9684906665706381 -227,2018-11-22,-107.97500000000001,45.325,0.9684900573913823 -227,2018-11-23,-107.97500000000001,45.325,0.9684894482121266 -227,2018-11-24,-107.97500000000001,45.325,0.9684888390328708 -227,2018-11-25,-107.97500000000001,45.325,0.968488229853615 -227,2018-11-26,-107.97500000000001,45.325,0.9684876206743592 -227,2018-11-27,-107.97500000000001,45.325,0.9684870114951035 -227,2018-11-28,-107.97500000000001,45.325,0.9684864023158478 -227,2018-11-29,-107.97500000000001,45.325,0.968485793136592 -227,2018-11-30,-107.97500000000001,45.325,0.9684851839573363 -227,2018-12-01,-107.97500000000001,45.325,0.9684845747780805 -227,2018-12-02,-107.97500000000001,45.325,0.9684840391926812 -227,2018-12-03,-107.97500000000001,45.325,0.9684835036072819 -227,2018-12-04,-107.97500000000001,45.325,0.9684829680218826 -227,2018-12-05,-107.97500000000001,45.325,0.9684824324364834 -227,2018-12-06,-107.97500000000001,45.325,0.968481896851084 -227,2018-12-07,-107.97500000000001,45.325,0.9684813612656847 -227,2018-12-08,-107.97500000000001,45.325,0.9684808256802855 -227,2018-12-09,-107.97500000000001,45.325,0.9684802900948861 -227,2018-12-10,-107.97500000000001,45.325,0.9684797545094869 -227,2018-12-11,-107.97500000000001,45.325,0.9684792189240875 -227,2018-12-12,-107.97500000000001,45.325,0.9684786833386883 -227,2018-12-13,-107.97500000000001,45.325,0.968478147753289 -227,2018-12-14,-107.97500000000001,45.325,0.9684776121678896 -227,2018-12-15,-107.97500000000001,45.325,0.9684770765824904 -227,2018-12-16,-107.97500000000001,45.325,0.968476540997091 -227,2018-12-17,-107.97500000000001,45.325,0.9684760054116918 -227,2018-12-18,-107.97500000000001,45.325,0.9684754698262925 -227,2018-12-19,-107.97500000000001,45.325,0.9684749342408931 -227,2018-12-20,-107.97500000000001,45.325,0.9684743986554939 -227,2018-12-21,-107.97500000000001,45.325,0.9684738630700945 -227,2018-12-22,-107.97500000000001,45.325,0.9684733274846953 -227,2018-12-23,-107.97500000000001,45.325,0.968472791899296 -227,2018-12-24,-107.97500000000001,45.325,0.9684722563138967 -227,2018-12-25,-107.97500000000001,45.325,0.9684717207284974 -227,2018-12-26,-107.97500000000001,45.325,0.9684711851430982 -227,2018-12-27,-107.97500000000001,45.325,0.9684706495576988 -227,2018-12-28,-107.97500000000001,45.325,0.9684701139722995 -227,2018-12-29,-107.97500000000001,45.325,0.9684695783869002 -227,2018-12-30,-107.97500000000001,45.325,0.9684690428015009 -227,2018-12-31,-107.97500000000001,45.325,0.9684685072161017 -227,2019-01-01,-107.97500000000001,45.325,0.9684679716307023 -227,2019-01-02,-107.97500000000001,45.325,0.9684674224126738 -227,2019-01-03,-107.97500000000001,45.325,0.9684668731946453 -227,2019-01-04,-107.97500000000001,45.325,0.9684663239766168 -227,2019-01-05,-107.97500000000001,45.325,0.9684657747585882 -227,2019-01-06,-107.97500000000001,45.325,0.9684652255405597 -227,2019-01-07,-107.97500000000001,45.325,0.9684646763225312 -227,2019-01-08,-107.97500000000001,45.325,0.9684641271045027 -227,2019-01-09,-107.97500000000001,45.325,0.9684635778864741 -227,2019-01-10,-107.97500000000001,45.325,0.9684630286684456 -227,2019-01-11,-107.97500000000001,45.325,0.9684624794504171 -227,2019-01-12,-107.97500000000001,45.325,0.9684619302323886 -227,2019-01-13,-107.97500000000001,45.325,0.9684613810143601 -227,2019-01-14,-107.97500000000001,45.325,0.9684608317963315 -227,2019-01-15,-107.97500000000001,45.325,0.968460282578303 -227,2019-01-16,-107.97500000000001,45.325,0.9684597333602745 -227,2019-01-17,-107.97500000000001,45.325,0.968459184142246 -227,2019-01-18,-107.97500000000001,45.325,0.9684586349242175 -227,2019-01-19,-107.97500000000001,45.325,0.9684580857061889 -227,2019-01-20,-107.97500000000001,45.325,0.9684575364881604 -227,2019-01-21,-107.97500000000001,45.325,0.9684569872701319 -227,2019-01-22,-107.97500000000001,45.325,0.9684564380521034 -227,2019-01-23,-107.97500000000001,45.325,0.9684558888340747 -227,2019-01-24,-107.97500000000001,45.325,0.9684553396160462 -227,2019-01-25,-107.97500000000001,45.325,0.9684547903980177 -227,2019-01-26,-107.97500000000001,45.325,0.9684542411799892 -227,2019-01-27,-107.97500000000001,45.325,0.9684536919619607 -227,2019-01-28,-107.97500000000001,45.325,0.9684531427439321 -227,2019-01-29,-107.97500000000001,45.325,0.9684525935259036 -227,2019-01-30,-107.97500000000001,45.325,0.9684520443078751 -227,2019-01-31,-107.97500000000001,45.325,0.9684514950898466 -227,2019-02-01,-107.97500000000001,45.325,0.968450945871818 -227,2019-02-02,-107.97500000000001,45.325,0.968450400030152 -227,2019-02-03,-107.97500000000001,45.325,0.968449854188486 -227,2019-02-04,-107.97500000000001,45.325,0.9684493083468199 -227,2019-02-05,-107.97500000000001,45.325,0.9684487625051538 -227,2019-02-06,-107.97500000000001,45.325,0.9684482166634878 -227,2019-02-07,-107.97500000000001,45.325,0.9684476708218217 -227,2019-02-08,-107.97500000000001,45.325,0.9684471249801556 -227,2019-02-09,-107.97500000000001,45.325,0.9684465791384895 -227,2019-02-10,-107.97500000000001,45.325,0.9684460332968235 -227,2019-02-11,-107.97500000000001,45.325,0.9684454874551575 -227,2019-02-12,-107.97500000000001,45.325,0.9684449416134914 -227,2019-02-13,-107.97500000000001,45.325,0.9684443957718253 -227,2019-02-14,-107.97500000000001,45.325,0.9684438499301593 -227,2019-02-15,-107.97500000000001,45.325,0.9684433040884932 -227,2019-02-16,-107.97500000000001,45.325,0.9684427582468271 -227,2019-02-17,-107.97500000000001,45.325,0.968442212405161 -227,2019-02-18,-107.97500000000001,45.325,0.968441666563495 -227,2019-02-19,-107.97500000000001,45.325,0.968441120721829 -227,2019-02-20,-107.97500000000001,45.325,0.9684405748801629 -227,2019-02-21,-107.97500000000001,45.325,0.9684400290384968 -227,2019-02-22,-107.97500000000001,45.325,0.9684394831968307 -227,2019-02-23,-107.97500000000001,45.325,0.9684389373551647 -227,2019-02-24,-107.97500000000001,45.325,0.9684383915134986 -227,2019-02-25,-107.97500000000001,45.325,0.9684378456718326 -227,2019-02-26,-107.97500000000001,45.325,0.9684372998301665 -227,2019-02-27,-107.97500000000001,45.325,0.9684367539885005 -227,2019-02-28,-107.97500000000001,45.325,0.9684362081468344 -227,2019-03-01,-107.97500000000001,45.325,0.9684356623051683 -227,2019-03-02,-107.97500000000001,45.325,0.9684350712177513 -227,2019-03-03,-107.97500000000001,45.325,0.9684344801303344 -227,2019-03-04,-107.97500000000001,45.325,0.9684338890429174 -227,2019-03-05,-107.97500000000001,45.325,0.9684332979555004 -227,2019-03-06,-107.97500000000001,45.325,0.9684327068680834 -227,2019-03-07,-107.97500000000001,45.325,0.9684321157806665 -227,2019-03-08,-107.97500000000001,45.325,0.9684315246932494 -227,2019-03-09,-107.97500000000001,45.325,0.9684309336058324 -227,2019-03-10,-107.97500000000001,45.325,0.9684303425184155 -227,2019-03-11,-107.97500000000001,45.325,0.9684297514309985 -227,2019-03-12,-107.97500000000001,45.325,0.9684291603435815 -227,2019-03-13,-107.97500000000001,45.325,0.9684285692561645 -227,2019-03-14,-107.97500000000001,45.325,0.9684279781687476 -227,2019-03-15,-107.97500000000001,45.325,0.9684273870813306 -227,2019-03-16,-107.97500000000001,45.325,0.9684267959939136 -227,2019-03-17,-107.97500000000001,45.325,0.9684262049064967 -227,2019-03-18,-107.97500000000001,45.325,0.9684256138190797 -227,2019-03-19,-107.97500000000001,45.325,0.9684250227316626 -227,2019-03-20,-107.97500000000001,45.325,0.9684244316442456 -227,2019-03-21,-107.97500000000001,45.325,0.9684238405568287 -227,2019-03-22,-107.97500000000001,45.325,0.9684232494694117 -227,2019-03-23,-107.97500000000001,45.325,0.9684226583819947 -227,2019-03-24,-107.97500000000001,45.325,0.9684220672945778 -227,2019-03-25,-107.97500000000001,45.325,0.9684214762071608 -227,2019-03-26,-107.97500000000001,45.325,0.9684208851197438 -227,2019-03-27,-107.97500000000001,45.325,0.9684202940323268 -227,2019-03-28,-107.97500000000001,45.325,0.9684197029449099 -227,2019-03-29,-107.97500000000001,45.325,0.9684191118574929 -227,2019-03-30,-107.97500000000001,45.325,0.9684185207700758 -227,2019-03-31,-107.97500000000001,45.325,0.9684179296826589 -227,2019-04-01,-107.97500000000001,45.325,0.9684173385952419 -227,2019-04-02,-107.97500000000001,45.325,0.9684166149854382 -227,2019-04-03,-107.97500000000001,45.325,0.9684158913756344 -227,2019-04-04,-107.97500000000001,45.325,0.9684151677658307 -227,2019-04-05,-107.97500000000001,45.325,0.9684144441560271 -227,2019-04-06,-107.97500000000001,45.325,0.9684136024716941 -227,2019-04-07,-107.97500000000001,45.325,0.9684128788618903 -227,2019-04-08,-107.97500000000001,45.325,0.9684120994966997 -227,2019-04-09,-107.97500000000001,45.325,0.9684113758868961 -227,2019-04-10,-107.97500000000001,45.325,0.9684106522770923 -227,2019-04-11,-107.97500000000001,45.325,0.9684099286672886 -227,2019-04-12,-107.97500000000001,45.325,0.9684092050574848 -227,2019-04-13,-107.97500000000001,45.325,0.9684084814476811 -227,2019-04-14,-107.97500000000001,45.325,0.9684077578378774 -227,2019-04-15,-107.97500000000001,45.325,0.9684070342280737 -227,2019-04-16,-107.97500000000001,45.325,0.9684062413380974 -227,2019-04-17,-107.97500000000001,45.325,0.9684055177282936 -227,2019-04-18,-107.97500000000001,45.325,0.9684047941184899 -227,2019-04-19,-107.97500000000001,45.325,0.9684038881084561 -227,2019-04-20,-107.97500000000001,45.325,0.9684015175923424 -227,2019-04-21,-107.97500000000001,45.325,0.9684002904784389 -227,2019-04-22,-107.97500000000001,45.325,0.9683995668686352 -227,2019-04-23,-107.97500000000001,45.325,0.9683988432588315 -227,2019-04-24,-107.97500000000001,45.325,0.9683979703666499 -227,2019-04-25,-107.97500000000001,45.325,0.9683972467568461 -227,2019-04-26,-107.97500000000001,45.325,0.9683965161308573 -227,2019-04-27,-107.97500000000001,45.325,0.9683957925210537 -227,2019-04-28,-107.97500000000001,45.325,0.9683950689112499 -227,2019-04-29,-107.97500000000001,45.325,0.9683941554669484 -227,2019-04-30,-107.97500000000001,45.325,0.9683934318571447 -227,2019-05-01,-107.97500000000001,45.325,0.9683927082473409 -227,2019-05-02,-107.97500000000001,45.325,0.9683919982586465 -227,2019-05-03,-107.97500000000001,45.325,0.968391288269952 -227,2019-05-04,-107.97500000000001,45.325,0.9683905782812576 -227,2019-05-05,-107.97500000000001,45.325,0.9683898682925632 -227,2019-05-06,-107.97500000000001,45.325,0.9683891583038687 -227,2019-05-07,-107.97500000000001,45.325,0.9683884483151743 -227,2019-05-08,-107.97500000000001,45.325,0.96838773832648 -227,2019-05-09,-107.97500000000001,45.325,0.9683870283377854 -227,2019-05-10,-107.97500000000001,45.325,0.9683863183490911 -227,2019-05-11,-107.97500000000001,45.325,0.9683856083603966 -227,2019-05-12,-107.97500000000001,45.325,0.9680605869058376 -227,2019-05-13,-107.97500000000001,45.325,0.966666772830601 -227,2019-05-14,-107.97500000000001,45.325,0.9652225209504431 -227,2019-05-15,-107.97500000000001,45.325,0.9638356902576579 -227,2019-05-16,-107.97500000000001,45.325,0.9625202101039919 -227,2019-05-17,-107.97500000000001,45.325,0.961529409296824 -227,2019-05-18,-107.97500000000001,45.325,0.9612247046407263 -227,2019-05-19,-107.97500000000001,45.325,0.9622914588705914 -227,2019-05-20,-107.97500000000001,45.325,0.9653196749310703 -227,2019-05-21,-107.97500000000001,45.325,0.9689743995915855 -227,2019-05-22,-107.97500000000001,45.325,0.971841624657512 -227,2019-05-23,-107.97500000000001,45.325,0.9731287031463391 -227,2019-05-24,-107.97500000000001,45.325,0.9741874711435029 -227,2019-05-25,-107.97500000000001,45.325,0.9768628751030202 -227,2019-05-26,-107.97500000000001,45.325,0.9796350586840797 -227,2019-05-27,-107.97500000000001,45.325,0.9831685153571589 -227,2019-05-28,-107.97500000000001,45.325,0.9868370007407581 -227,2019-05-29,-107.97500000000001,45.325,0.9912398069036473 -227,2019-05-30,-107.97500000000001,45.325,0.9986650719233195 -227,2019-05-31,-107.97500000000001,45.325,1.0 -227,2019-06-01,-107.97500000000001,45.325,1.0 -227,2019-06-02,-107.97500000000001,45.325,0.9983401822950393 -227,2019-06-03,-107.97500000000001,45.325,0.9960955176238467 -227,2019-06-04,-107.97500000000001,45.325,0.9947791552426063 -227,2019-06-05,-107.97500000000001,45.325,0.9946990606614369 -227,2019-06-06,-107.97500000000001,45.325,0.9953757536346959 -227,2019-06-07,-107.97500000000001,45.325,0.9964460035333552 -227,2019-06-08,-107.97500000000001,45.325,0.9976853315489121 -227,2019-06-09,-107.97500000000001,45.325,0.9990282417398895 -227,2019-06-10,-107.97500000000001,45.325,1.0 -227,2019-06-11,-107.97500000000001,45.325,1.0 -227,2019-06-12,-107.97500000000001,45.325,0.9990716462881086 -227,2019-06-13,-107.97500000000001,45.325,0.9972413280815708 -227,2019-06-14,-107.97500000000001,45.325,0.9960539734766375 -227,2019-06-15,-107.97500000000001,45.325,0.9955957899761224 -227,2019-06-16,-107.97500000000001,45.325,0.9965337361050938 -227,2019-06-17,-107.97500000000001,45.325,0.9983865910826607 -227,2019-06-18,-107.97500000000001,45.325,1.0 -227,2019-06-19,-107.97500000000001,45.325,1.0 -227,2019-06-20,-107.97500000000001,45.325,1.0 -227,2019-06-21,-107.97500000000001,45.325,1.0 -227,2019-06-22,-107.97500000000001,45.325,1.0 -227,2019-06-23,-107.97500000000001,45.325,0.9996813876804437 -227,2019-06-24,-107.97500000000001,45.325,0.9983423333948749 -227,2019-06-25,-107.97500000000001,45.325,0.9967661056584685 -227,2019-06-26,-107.97500000000001,45.325,0.995507772146965 -227,2019-06-27,-107.97500000000001,45.325,0.9949378082476736 -227,2019-06-28,-107.97500000000001,45.325,0.9948414406928581 -227,2019-06-29,-107.97500000000001,45.325,0.9955255548195101 -227,2019-06-30,-107.97500000000001,45.325,0.9968511038028997 -227,2019-07-01,-107.97500000000001,45.325,0.9978869058253024 -227,2019-07-02,-107.97500000000001,45.325,0.9981374496976846 -227,2019-07-03,-107.97500000000001,45.325,0.9978394757257018 -227,2019-07-04,-107.97500000000001,45.325,0.9971710672200922 -227,2019-07-05,-107.97500000000001,45.325,0.9963579421221419 -227,2019-07-06,-107.97500000000001,45.325,0.9959304568820314 -227,2019-07-07,-107.97500000000001,45.325,0.996279750911815 -227,2019-07-08,-107.97500000000001,45.325,0.9966015810082479 -227,2019-07-09,-107.97500000000001,45.325,0.9959903136027046 -227,2019-07-10,-107.97500000000001,45.325,0.9950210774332007 -227,2019-07-11,-107.97500000000001,45.325,0.9942673387258681 -227,2019-07-12,-107.97500000000001,45.325,0.9937878858615656 -227,2019-07-13,-107.97500000000001,45.325,0.9932275331639616 -227,2019-07-14,-107.97500000000001,45.325,0.9925223629058758 -227,2019-07-15,-107.97500000000001,45.325,0.9918407213627921 -227,2019-07-16,-107.97500000000001,45.325,0.9912729286232588 -227,2019-07-17,-107.97500000000001,45.325,0.9908692582664226 -227,2019-07-18,-107.97500000000001,45.325,0.9906057831702967 -227,2019-07-19,-107.97500000000001,45.325,0.9903653188564739 -227,2019-07-20,-107.97500000000001,45.325,0.990135797812441 -227,2019-07-21,-107.97500000000001,45.325,0.9897509131505369 -227,2019-07-22,-107.97500000000001,45.325,0.9889096389878359 -227,2019-07-23,-107.97500000000001,45.325,0.9876284856445491 -227,2019-07-24,-107.97500000000001,45.325,0.9859993736675932 -227,2019-07-25,-107.97500000000001,45.325,0.9841224027996807 -227,2019-07-26,-107.97500000000001,45.325,0.9821406388120298 -227,2019-07-27,-107.97500000000001,45.325,0.9801805029518275 -227,2019-07-28,-107.97500000000001,45.325,0.978246911267373 -227,2019-07-29,-107.97500000000001,45.325,0.9763415933486784 -227,2019-07-30,-107.97500000000001,45.325,0.9744568239251175 -227,2019-07-31,-107.97500000000001,45.325,0.9725657622882503 -227,2019-08-01,-107.97500000000001,45.325,0.9706749251293321 -227,2019-08-02,-107.97500000000001,45.325,0.9688024501329404 -227,2019-08-03,-107.97500000000001,45.325,0.9681828121634561 -227,2019-08-04,-107.97500000000001,45.325,0.9681765309355524 -227,2019-08-05,-107.97500000000001,45.325,0.9681694126088554 -227,2019-08-06,-107.97500000000001,45.325,0.9681657055326823 -227,2019-08-07,-107.97500000000001,45.325,0.9681626407538165 -227,2019-08-08,-107.97500000000001,45.325,0.9681562677059184 -227,2019-08-09,-107.97500000000001,45.325,0.9681539460019915 -227,2019-08-10,-107.97500000000001,45.325,0.9681509624484281 -227,2019-08-11,-107.97500000000001,45.325,0.9681476658731718 -227,2019-08-12,-107.97500000000001,45.325,0.9681456215074581 -227,2019-08-13,-107.97500000000001,45.325,0.968141955380137 -227,2019-08-14,-107.97500000000001,45.325,0.9681391576495836 -227,2019-08-15,-107.97500000000001,45.325,0.9681370275870546 -227,2019-08-16,-107.97500000000001,45.325,0.9681309319016264 -227,2019-08-17,-107.97500000000001,45.325,0.9681283149751254 -227,2019-08-18,-107.97500000000001,45.325,0.9681268100939846 -227,2019-08-19,-107.97500000000001,45.325,0.9681249936763408 -227,2019-08-20,-107.97500000000001,45.325,0.9681171399487596 -227,2019-08-21,-107.97500000000001,45.325,0.9681086815062352 -227,2019-08-22,-107.97500000000001,45.325,0.9681048045672936 -227,2019-08-23,-107.97500000000001,45.325,0.9681005264190289 -227,2019-08-24,-107.97500000000001,45.325,0.9680980789867529 -227,2019-08-25,-107.97500000000001,45.325,0.9680967919099879 -227,2019-08-26,-107.97500000000001,45.325,0.9680913304817589 -227,2019-08-27,-107.97500000000001,45.325,0.9680876665761379 -227,2019-08-28,-107.97500000000001,45.325,0.9680845375303471 -227,2019-08-29,-107.97500000000001,45.325,0.968080821485402 -227,2019-08-30,-107.97500000000001,45.325,0.9680744552057509 -227,2019-08-31,-107.97500000000001,45.325,0.9680703736786441 -227,2019-09-01,-107.97500000000001,45.325,0.9680688096209853 -227,2019-09-02,-107.97500000000001,45.325,0.9680626091716663 -227,2019-09-03,-107.97500000000001,45.325,0.9680569883648114 -227,2019-09-04,-107.97500000000001,45.325,0.9680502145930103 -227,2019-09-05,-107.97500000000001,45.325,0.9680423393058295 -227,2019-09-06,-107.97500000000001,45.325,0.9680333025771546 -227,2019-09-07,-107.97500000000001,45.325,0.9680308605775944 -227,2019-09-08,-107.97500000000001,45.325,0.9680300322290809 -227,2019-09-09,-107.97500000000001,45.325,0.9680291950476639 -227,2019-09-10,-107.97500000000001,45.325,0.9680283666991505 -227,2019-09-11,-107.97500000000001,45.325,0.968027538350637 -227,2019-09-12,-107.97500000000001,45.325,0.9680267100021236 -227,2019-09-13,-107.97500000000001,45.325,0.9680258816536101 -227,2019-09-14,-107.97500000000001,45.325,0.9680250533050967 -227,2019-09-15,-107.97500000000001,45.325,0.9680242249565444 -227,2019-09-16,-107.97500000000001,45.325,0.968023159264621 -227,2019-09-17,-107.97500000000001,45.325,0.9680212755145133 -227,2019-09-18,-107.97500000000001,45.325,0.9680204471659999 -227,2019-09-19,-107.97500000000001,45.325,0.9680196188174864 -227,2019-09-20,-107.97500000000001,45.325,0.968018790468973 -227,2019-09-21,-107.97500000000001,45.325,0.9680179621204595 -227,2019-09-22,-107.97500000000001,45.325,0.9680171337719461 -227,2019-09-23,-107.97500000000001,45.325,0.9680163054234326 -227,2019-09-24,-107.97500000000001,45.325,0.9680154770749192 -227,2019-09-25,-107.97500000000001,45.325,0.9680146487264057 -227,2019-09-26,-107.97500000000001,45.325,0.9680138203778923 -227,2019-09-27,-107.97500000000001,45.325,0.9680129920293788 -227,2019-09-28,-107.97500000000001,45.325,0.9680121636808654 -227,2019-09-29,-107.97500000000001,45.325,0.9680113353323521 -227,2019-09-30,-107.97500000000001,45.325,0.9680105069838386 -227,2019-10-01,-107.97500000000001,45.325,0.9680096786353252 -227,2019-10-02,-107.97500000000001,45.325,0.9680090507569223 -227,2019-10-03,-107.97500000000001,45.325,0.9680084228785195 -227,2019-10-04,-107.97500000000001,45.325,0.9680077950001167 -227,2019-10-05,-107.97500000000001,45.325,0.968007167121714 -227,2019-10-06,-107.97500000000001,45.325,0.9680065392433111 -227,2019-10-07,-107.97500000000001,45.325,0.9680059113649083 -227,2019-10-08,-107.97500000000001,45.325,0.9680052834865055 -227,2019-10-09,-107.97500000000001,45.325,0.9680046556081027 -227,2019-10-10,-107.97500000000001,45.325,0.9680040277297 -227,2019-10-11,-107.97500000000001,45.325,0.9680033998512971 -227,2019-10-12,-107.97500000000001,45.325,0.9680027719728943 -227,2019-10-13,-107.97500000000001,45.325,0.9680021440944915 -227,2019-10-14,-107.97500000000001,45.325,0.9680015162160888 -227,2019-10-15,-107.97500000000001,45.325,0.9680008883376859 -227,2019-10-16,-107.97500000000001,45.325,0.9680002604592831 -227,2019-10-17,-107.97500000000001,45.325,0.9679996325808803 -227,2019-10-18,-107.97500000000001,45.325,0.9679990047024776 -227,2019-10-19,-107.97500000000001,45.325,0.9679983768240747 -227,2019-10-20,-107.97500000000001,45.325,0.9679977489456719 -227,2019-10-21,-107.97500000000001,45.325,0.9679971210672691 -227,2019-10-22,-107.97500000000001,45.325,0.9679964931888664 -227,2019-10-23,-107.97500000000001,45.325,0.9679958653104636 -227,2019-10-24,-107.97500000000001,45.325,0.9679952374320607 -227,2019-10-25,-107.97500000000001,45.325,0.9679946095536579 -227,2019-10-26,-107.97500000000001,45.325,0.9679939816752551 -227,2019-10-27,-107.97500000000001,45.325,0.9679933537968524 -227,2019-10-28,-107.97500000000001,45.325,0.9679927259184495 -227,2019-10-29,-107.97500000000001,45.325,0.9679920980400467 -227,2019-10-30,-107.97500000000001,45.325,0.9679914701616439 -227,2019-10-31,-107.97500000000001,45.325,0.9679908422832412 -227,2019-11-01,-107.97500000000001,45.325,0.9679902144048383 -227,2019-11-02,-107.97500000000001,45.325,0.9679895916468563 -227,2019-11-03,-107.97500000000001,45.325,0.9679889688888743 -227,2019-11-04,-107.97500000000001,45.325,0.9679883461308924 -227,2019-11-05,-107.97500000000001,45.325,0.9679877233729103 -227,2019-11-06,-107.97500000000001,45.325,0.9679871006149283 -227,2019-11-07,-107.97500000000001,45.325,0.9679864778569464 -227,2019-11-08,-107.97500000000001,45.325,0.9679858550989643 -227,2019-11-09,-107.97500000000001,45.325,0.9679852323409823 -227,2019-11-10,-107.97500000000001,45.325,0.9679846095830004 -227,2019-11-11,-107.97500000000001,45.325,0.9679839868250183 -227,2019-11-12,-107.97500000000001,45.325,0.9679833640670363 -227,2019-11-13,-107.97500000000001,45.325,0.9679827413090544 -227,2019-11-14,-107.97500000000001,45.325,0.9679821185510723 -227,2019-11-15,-107.97500000000001,45.325,0.9679814957930903 -227,2019-11-16,-107.97500000000001,45.325,0.9679808730351084 -227,2019-11-17,-107.97500000000001,45.325,0.9679802502771263 -227,2019-11-18,-107.97500000000001,45.325,0.9679796275191443 -227,2019-11-19,-107.97500000000001,45.325,0.9679790047611624 -227,2019-11-20,-107.97500000000001,45.325,0.9679783820031803 -227,2019-11-21,-107.97500000000001,45.325,0.9679777592451984 -227,2019-11-22,-107.97500000000001,45.325,0.9679771364872164 -227,2019-11-23,-107.97500000000001,45.325,0.9679765137292343 -227,2019-11-24,-107.97500000000001,45.325,0.9679758909712524 -227,2019-11-25,-107.97500000000001,45.325,0.9679752682132704 -227,2019-11-26,-107.97500000000001,45.325,0.9679746454552883 -227,2019-11-27,-107.97500000000001,45.325,0.9679740226973064 -227,2019-11-28,-107.97500000000001,45.325,0.9679733999393244 -227,2019-11-29,-107.97500000000001,45.325,0.9679727771813423 -227,2019-11-30,-107.97500000000001,45.325,0.9679721544233604 -227,2019-12-01,-107.97500000000001,45.325,0.9679715316653784 -227,2019-12-02,-107.97500000000001,45.325,0.9679709813026096 -227,2019-12-03,-107.97500000000001,45.325,0.9679704309398409 -227,2019-12-04,-107.97500000000001,45.325,0.9679698805770722 -227,2019-12-05,-107.97500000000001,45.325,0.9679693302143034 -227,2019-12-06,-107.97500000000001,45.325,0.9679687798515347 -227,2019-12-07,-107.97500000000001,45.325,0.967968229488766 -227,2019-12-08,-107.97500000000001,45.325,0.9679676791259973 -227,2019-12-09,-107.97500000000001,45.325,0.9679671287632285 -227,2019-12-10,-107.97500000000001,45.325,0.9679665784004599 -227,2019-12-11,-107.97500000000001,45.325,0.9679660280376912 -227,2019-12-12,-107.97500000000001,45.325,0.9679654776749224 -227,2019-12-13,-107.97500000000001,45.325,0.9679649273121537 -227,2019-12-14,-107.97500000000001,45.325,0.967964376949385 -227,2019-12-15,-107.97500000000001,45.325,0.9679638265866162 -227,2019-12-16,-107.97500000000001,45.325,0.9679632762238475 -227,2019-12-17,-107.97500000000001,45.325,0.9679627258610788 -227,2019-12-18,-107.97500000000001,45.325,0.96796217549831 -227,2019-12-19,-107.97500000000001,45.325,0.9679616251355413 -227,2019-12-20,-107.97500000000001,45.325,0.9679610747727726 -227,2019-12-21,-107.97500000000001,45.325,0.9679605244100039 -227,2019-12-22,-107.97500000000001,45.325,0.9679599740472351 -227,2019-12-23,-107.97500000000001,45.325,0.9679594236844664 -227,2019-12-24,-107.97500000000001,45.325,0.9679588733216977 -227,2019-12-25,-107.97500000000001,45.325,0.9679583229589289 -227,2019-12-26,-107.97500000000001,45.325,0.9679577725961602 -227,2019-12-27,-107.97500000000001,45.325,0.9679572222333915 -227,2019-12-28,-107.97500000000001,45.325,0.9679566718706227 -227,2019-12-29,-107.97500000000001,45.325,0.967956121507854 -227,2019-12-30,-107.97500000000001,45.325,0.9679555711450853 -227,2019-12-31,-107.97500000000001,45.325,0.9679550207823165 -227,2020-01-01,-107.97500000000001,45.325,0.9679544704195479 -364,2018-01-02,-111.67500000000001,46.62500000000001,0.9673196580513111 -364,2018-01-03,-111.67500000000001,46.62500000000001,0.9673180699935565 -364,2018-01-04,-111.67500000000001,46.62500000000001,0.9673164819358019 -364,2018-01-05,-111.67500000000001,46.62500000000001,0.9673148938780473 -364,2018-01-06,-111.67500000000001,46.62500000000001,0.9673133058202926 -364,2018-01-07,-111.67500000000001,46.62500000000001,0.967311717762538 -364,2018-01-08,-111.67500000000001,46.62500000000001,0.9673101297047834 -364,2018-01-09,-111.67500000000001,46.62500000000001,0.9673085416470287 -364,2018-01-10,-111.67500000000001,46.62500000000001,0.9673069535892741 -364,2018-01-11,-111.67500000000001,46.62500000000001,0.9673053655315195 -364,2018-01-12,-111.67500000000001,46.62500000000001,0.9673037774737648 -364,2018-01-13,-111.67500000000001,46.62500000000001,0.9673021894160102 -364,2018-01-14,-111.67500000000001,46.62500000000001,0.9673006013582556 -364,2018-01-15,-111.67500000000001,46.62500000000001,0.9672990133005009 -364,2018-01-16,-111.67500000000001,46.62500000000001,0.9672974252427463 -364,2018-01-17,-111.67500000000001,46.62500000000001,0.9672958371849917 -364,2018-01-18,-111.67500000000001,46.62500000000001,0.967294249127237 -364,2018-01-19,-111.67500000000001,46.62500000000001,0.9672926610694824 -364,2018-01-20,-111.67500000000001,46.62500000000001,0.9672910730117277 -364,2018-01-21,-111.67500000000001,46.62500000000001,0.967289484953973 -364,2018-01-22,-111.67500000000001,46.62500000000001,0.9672878968962184 -364,2018-01-23,-111.67500000000001,46.62500000000001,0.9672863088384638 -364,2018-01-24,-111.67500000000001,46.62500000000001,0.9672847207807092 -364,2018-01-25,-111.67500000000001,46.62500000000001,0.9672831327229545 -364,2018-01-26,-111.67500000000001,46.62500000000001,0.9672815446651999 -364,2018-01-27,-111.67500000000001,46.62500000000001,0.9672799566074453 -364,2018-01-28,-111.67500000000001,46.62500000000001,0.9672783685496906 -364,2018-01-29,-111.67500000000001,46.62500000000001,0.967276780491936 -364,2018-01-30,-111.67500000000001,46.62500000000001,0.9672751924341814 -364,2018-01-31,-111.67500000000001,46.62500000000001,0.9672736043764267 -364,2018-02-01,-111.67500000000001,46.62500000000001,0.9672720163186721 -364,2018-02-02,-111.67500000000001,46.62500000000001,0.9672704829964844 -364,2018-02-03,-111.67500000000001,46.62500000000001,0.9672689496742968 -364,2018-02-04,-111.67500000000001,46.62500000000001,0.9672674163521091 -364,2018-02-05,-111.67500000000001,46.62500000000001,0.9672658830299214 -364,2018-02-06,-111.67500000000001,46.62500000000001,0.9672643497077338 -364,2018-02-07,-111.67500000000001,46.62500000000001,0.9672628163855461 -364,2018-02-08,-111.67500000000001,46.62500000000001,0.9672612830633585 -364,2018-02-09,-111.67500000000001,46.62500000000001,0.9672597497411708 -364,2018-02-10,-111.67500000000001,46.62500000000001,0.9672582164189831 -364,2018-02-11,-111.67500000000001,46.62500000000001,0.9672566830967955 -364,2018-02-12,-111.67500000000001,46.62500000000001,0.9672551497746078 -364,2018-02-13,-111.67500000000001,46.62500000000001,0.9672536164524201 -364,2018-02-14,-111.67500000000001,46.62500000000001,0.9672520831302325 -364,2018-02-15,-111.67500000000001,46.62500000000001,0.9672505498080448 -364,2018-02-16,-111.67500000000001,46.62500000000001,0.9672490164858571 -364,2018-02-17,-111.67500000000001,46.62500000000001,0.9672474831636695 -364,2018-02-18,-111.67500000000001,46.62500000000001,0.9672459498414818 -364,2018-02-19,-111.67500000000001,46.62500000000001,0.9672444165192942 -364,2018-02-20,-111.67500000000001,46.62500000000001,0.9672428831971065 -364,2018-02-21,-111.67500000000001,46.62500000000001,0.9672413498749188 -364,2018-02-22,-111.67500000000001,46.62500000000001,0.9672398165527312 -364,2018-02-23,-111.67500000000001,46.62500000000001,0.9672382832305435 -364,2018-02-24,-111.67500000000001,46.62500000000001,0.9672367499083558 -364,2018-02-25,-111.67500000000001,46.62500000000001,0.9672352165861682 -364,2018-02-26,-111.67500000000001,46.62500000000001,0.9672336832639805 -364,2018-02-27,-111.67500000000001,46.62500000000001,0.9672321499417929 -364,2018-02-28,-111.67500000000001,46.62500000000001,0.9672306166196052 -364,2018-03-01,-111.67500000000001,46.62500000000001,0.9672290832974175 -364,2018-03-02,-111.67500000000001,46.62500000000001,0.9672274145446116 -364,2018-03-03,-111.67500000000001,46.62500000000001,0.9672257457918055 -364,2018-03-04,-111.67500000000001,46.62500000000001,0.9672240770389996 -364,2018-03-05,-111.67500000000001,46.62500000000001,0.9672224082861937 -364,2018-03-06,-111.67500000000001,46.62500000000001,0.9672207395333876 -364,2018-03-07,-111.67500000000001,46.62500000000001,0.9672190707805817 -364,2018-03-08,-111.67500000000001,46.62500000000001,0.9672174020277756 -364,2018-03-09,-111.67500000000001,46.62500000000001,0.9672157332749697 -364,2018-03-10,-111.67500000000001,46.62500000000001,0.9672140645221636 -364,2018-03-11,-111.67500000000001,46.62500000000001,0.9672123957693577 -364,2018-03-12,-111.67500000000001,46.62500000000001,0.9672107270165516 -364,2018-03-13,-111.67500000000001,46.62500000000001,0.9672090582637457 -364,2018-03-14,-111.67500000000001,46.62500000000001,0.9672073895109398 -364,2018-03-15,-111.67500000000001,46.62500000000001,0.9672057207581337 -364,2018-03-16,-111.67500000000001,46.62500000000001,0.9672040520053278 -364,2018-03-17,-111.67500000000001,46.62500000000001,0.9672023832525217 -364,2018-03-18,-111.67500000000001,46.62500000000001,0.9672007144997158 -364,2018-03-19,-111.67500000000001,46.62500000000001,0.9671990457469097 -364,2018-03-20,-111.67500000000001,46.62500000000001,0.9671973769941038 -364,2018-03-21,-111.67500000000001,46.62500000000001,0.9671957082412977 -364,2018-03-22,-111.67500000000001,46.62500000000001,0.9671940394884918 -364,2018-03-23,-111.67500000000001,46.62500000000001,0.9671923707356859 -364,2018-03-24,-111.67500000000001,46.62500000000001,0.9671907019828798 -364,2018-03-25,-111.67500000000001,46.62500000000001,0.9671890332300739 -364,2018-03-26,-111.67500000000001,46.62500000000001,0.9671873644772678 -364,2018-03-27,-111.67500000000001,46.62500000000001,0.9671856957244619 -364,2018-03-28,-111.67500000000001,46.62500000000001,0.9671840269716558 -364,2018-03-29,-111.67500000000001,46.62500000000001,0.9671823582188499 -364,2018-03-30,-111.67500000000001,46.62500000000001,0.967180689466044 -364,2018-03-31,-111.67500000000001,46.62500000000001,0.9671790207132379 -364,2018-04-01,-111.67500000000001,46.62500000000001,0.967177351960432 -364,2018-04-02,-111.67500000000001,46.62500000000001,0.967175466725652 -364,2018-04-03,-111.67500000000001,46.62500000000001,0.9671735814908721 -364,2018-04-04,-111.67500000000001,46.62500000000001,0.9671716962560922 -364,2018-04-05,-111.67500000000001,46.62500000000001,0.9671698110213123 -364,2018-04-06,-111.67500000000001,46.62500000000001,0.9671679257865323 -364,2018-04-07,-111.67500000000001,46.62500000000001,0.9671660405517525 -364,2018-04-08,-111.67500000000001,46.62500000000001,0.9671641553169725 -364,2018-04-09,-111.67500000000001,46.62500000000001,0.9671622700821926 -364,2018-04-10,-111.67500000000001,46.62500000000001,0.9671603848474127 -364,2018-04-11,-111.67500000000001,46.62500000000001,0.9671584996126328 -364,2018-04-12,-111.67500000000001,46.62500000000001,0.9671566143778528 -364,2018-04-13,-111.67500000000001,46.62500000000001,0.967154729143073 -364,2018-04-14,-111.67500000000001,46.62500000000001,0.967152843908293 -364,2018-04-15,-111.67500000000001,46.62500000000001,0.9671509586735131 -364,2018-04-16,-111.67500000000001,46.62500000000001,0.9671490734387332 -364,2018-04-17,-111.67500000000001,46.62500000000001,0.9671471882039533 -364,2018-04-18,-111.67500000000001,46.62500000000001,0.9671453029691733 -364,2018-04-19,-111.67500000000001,46.62500000000001,0.9671434177343935 -364,2018-04-20,-111.67500000000001,46.62500000000001,0.9671415324996135 -364,2018-04-21,-111.67500000000001,46.62500000000001,0.9671396472648337 -364,2018-04-22,-111.67500000000001,46.62500000000001,0.9671377620300537 -364,2018-04-23,-111.67500000000001,46.62500000000001,0.9671358767952738 -364,2018-04-24,-111.67500000000001,46.62500000000001,0.967133991560494 -364,2018-04-25,-111.67500000000001,46.62500000000001,0.967132106325714 -364,2018-04-26,-111.67500000000001,46.62500000000001,0.967130221090934 -364,2018-04-27,-111.67500000000001,46.62500000000001,0.9671283358561542 -364,2018-04-28,-111.67500000000001,46.62500000000001,0.9671264506213743 -364,2018-04-29,-111.67500000000001,46.62500000000001,0.9671245653865943 -364,2018-04-30,-111.67500000000001,46.62500000000001,0.9667043146448699 -364,2018-05-01,-111.67500000000001,46.62500000000001,0.9664452180334199 -364,2018-05-02,-111.67500000000001,46.62500000000001,0.9682063871741168 -364,2018-05-03,-111.67500000000001,46.62500000000001,0.9715119355194847 -364,2018-05-04,-111.67500000000001,46.62500000000001,0.9751410057652173 -364,2018-05-05,-111.67500000000001,46.62500000000001,0.9783322499312581 -364,2018-05-06,-111.67500000000001,46.62500000000001,0.9810567528097895 -364,2018-05-07,-111.67500000000001,46.62500000000001,0.9838764514624162 -364,2018-05-08,-111.67500000000001,46.62500000000001,0.98756893977298 -364,2018-05-09,-111.67500000000001,46.62500000000001,0.9904893793069756 -364,2018-05-10,-111.67500000000001,46.62500000000001,0.9928645232804835 -364,2018-05-11,-111.67500000000001,46.62500000000001,0.9949296316504864 -364,2018-05-12,-111.67500000000001,46.62500000000001,0.9968263540678021 -364,2018-05-13,-111.67500000000001,46.62500000000001,0.9984200418451216 -364,2018-05-14,-111.67500000000001,46.62500000000001,0.9994837036111126 -364,2018-05-15,-111.67500000000001,46.62500000000001,0.9997499358872157 -364,2018-05-16,-111.67500000000001,46.62500000000001,0.9994927158175969 -364,2018-05-17,-111.67500000000001,46.62500000000001,0.9992210065943911 -364,2018-05-18,-111.67500000000001,46.62500000000001,0.9991915593798822 -364,2018-05-19,-111.67500000000001,46.62500000000001,0.9995836290430661 -364,2018-05-20,-111.67500000000001,46.62500000000001,1.0 -364,2018-05-21,-111.67500000000001,46.62500000000001,1.0 -364,2018-05-22,-111.67500000000001,46.62500000000001,1.0 -364,2018-05-23,-111.67500000000001,46.62500000000001,1.0 -364,2018-05-24,-111.67500000000001,46.62500000000001,1.0 -364,2018-05-25,-111.67500000000001,46.62500000000001,1.0 -364,2018-05-26,-111.67500000000001,46.62500000000001,1.0 -364,2018-05-27,-111.67500000000001,46.62500000000001,1.0 -364,2018-05-28,-111.67500000000001,46.62500000000001,1.0 -364,2018-05-29,-111.67500000000001,46.62500000000001,1.0 -364,2018-05-30,-111.67500000000001,46.62500000000001,1.0 -364,2018-05-31,-111.67500000000001,46.62500000000001,1.0 -364,2018-06-01,-111.67500000000001,46.62500000000001,1.0 -364,2018-06-02,-111.67500000000001,46.62500000000001,1.0 -364,2018-06-03,-111.67500000000001,46.62500000000001,1.0 -364,2018-06-04,-111.67500000000001,46.62500000000001,1.0 -364,2018-06-05,-111.67500000000001,46.62500000000001,1.0 -364,2018-06-06,-111.67500000000001,46.62500000000001,1.0 -364,2018-06-07,-111.67500000000001,46.62500000000001,1.0 -364,2018-06-08,-111.67500000000001,46.62500000000001,1.0 -364,2018-06-09,-111.67500000000001,46.62500000000001,1.0 -364,2018-06-10,-111.67500000000001,46.62500000000001,1.0 -364,2018-06-11,-111.67500000000001,46.62500000000001,1.0 -364,2018-06-12,-111.67500000000001,46.62500000000001,1.0 -364,2018-06-13,-111.67500000000001,46.62500000000001,1.0 -364,2018-06-14,-111.67500000000001,46.62500000000001,1.0 -364,2018-06-15,-111.67500000000001,46.62500000000001,1.0 -364,2018-06-16,-111.67500000000001,46.62500000000001,1.0 -364,2018-06-17,-111.67500000000001,46.62500000000001,1.0 -364,2018-06-18,-111.67500000000001,46.62500000000001,0.9999255241195967 -364,2018-06-19,-111.67500000000001,46.62500000000001,0.9999573567524856 -364,2018-06-20,-111.67500000000001,46.62500000000001,1.0 -364,2018-06-21,-111.67500000000001,46.62500000000001,1.0 -364,2018-06-22,-111.67500000000001,46.62500000000001,1.0 -364,2018-06-23,-111.67500000000001,46.62500000000001,1.0 -364,2018-06-24,-111.67500000000001,46.62500000000001,1.0 -364,2018-06-25,-111.67500000000001,46.62500000000001,1.0 -364,2018-06-26,-111.67500000000001,46.62500000000001,1.0 -364,2018-06-27,-111.67500000000001,46.62500000000001,0.9999281033377979 -364,2018-06-28,-111.67500000000001,46.62500000000001,0.9991658856517587 -364,2018-06-29,-111.67500000000001,46.62500000000001,0.9980260369138138 -364,2018-06-30,-111.67500000000001,46.62500000000001,0.9968458577332431 -364,2018-07-01,-111.67500000000001,46.62500000000001,0.9959347730778839 -364,2018-07-02,-111.67500000000001,46.62500000000001,0.9955558948619604 -364,2018-07-03,-111.67500000000001,46.62500000000001,0.9952918541145989 -364,2018-07-04,-111.67500000000001,46.62500000000001,0.9947733993526813 -364,2018-07-05,-111.67500000000001,46.62500000000001,0.9940474963193399 -364,2018-07-06,-111.67500000000001,46.62500000000001,0.9932939457166197 -364,2018-07-07,-111.67500000000001,46.62500000000001,0.9925239260576572 -364,2018-07-08,-111.67500000000001,46.62500000000001,0.9917162634490607 -364,2018-07-09,-111.67500000000001,46.62500000000001,0.9909255687981693 -364,2018-07-10,-111.67500000000001,46.62500000000001,0.9901949048481977 -364,2018-07-11,-111.67500000000001,46.62500000000001,0.9895382425341841 -364,2018-07-12,-111.67500000000001,46.62500000000001,0.988952893209491 -364,2018-07-13,-111.67500000000001,46.62500000000001,0.9884395324006802 -364,2018-07-14,-111.67500000000001,46.62500000000001,0.987975051167783 -364,2018-07-15,-111.67500000000001,46.62500000000001,0.9875354696534966 -364,2018-07-16,-111.67500000000001,46.62500000000001,0.9871281799589201 -364,2018-07-17,-111.67500000000001,46.62500000000001,0.9865742906618077 -364,2018-07-18,-111.67500000000001,46.62500000000001,0.9856543418603313 -364,2018-07-19,-111.67500000000001,46.62500000000001,0.9844158661475494 -364,2018-07-20,-111.67500000000001,46.62500000000001,0.9830210123597634 -364,2018-07-21,-111.67500000000001,46.62500000000001,0.9816576235251244 -364,2018-07-22,-111.67500000000001,46.62500000000001,0.9803451206721834 -364,2018-07-23,-111.67500000000001,46.62500000000001,0.9790694017562203 -364,2018-07-24,-111.67500000000001,46.62500000000001,0.9778383480769418 -364,2018-07-25,-111.67500000000001,46.62500000000001,0.9766423485498049 -364,2018-07-26,-111.67500000000001,46.62500000000001,0.9754776883848878 -364,2018-07-27,-111.67500000000001,46.62500000000001,0.9743381135194433 -364,2018-07-28,-111.67500000000001,46.62500000000001,0.9732163750393485 -364,2018-07-29,-111.67500000000001,46.62500000000001,0.9721090819232382 -364,2018-07-30,-111.67500000000001,46.62500000000001,0.9710129015821148 -364,2018-07-31,-111.67500000000001,46.62500000000001,0.9699189868282767 -364,2018-08-01,-111.67500000000001,46.62500000000001,0.9690262311905596 -364,2018-08-02,-111.67500000000001,46.62500000000001,0.9690076683442667 -364,2018-08-03,-111.67500000000001,46.62500000000001,0.9689719389443618 -364,2018-08-04,-111.67500000000001,46.62500000000001,0.9689663561132755 -364,2018-08-05,-111.67500000000001,46.62500000000001,0.9689596535298545 -364,2018-08-06,-111.67500000000001,46.62500000000001,0.9689547588588472 -364,2018-08-07,-111.67500000000001,46.62500000000001,0.9689408845342821 -364,2018-08-08,-111.67500000000001,46.62500000000001,0.9689208034739508 -364,2018-08-09,-111.67500000000001,46.62500000000001,0.9688908830715239 -364,2018-08-10,-111.67500000000001,46.62500000000001,0.9688740546584906 -364,2018-08-11,-111.67500000000001,46.62500000000001,0.9688375894287189 -364,2018-08-12,-111.67500000000001,46.62500000000001,0.9688072582947306 -364,2018-08-13,-111.67500000000001,46.62500000000001,0.9687795911838647 -364,2018-08-14,-111.67500000000001,46.62500000000001,0.968775251630344 -364,2018-08-15,-111.67500000000001,46.62500000000001,0.9687630881594336 -364,2018-08-16,-111.67500000000001,46.62500000000001,0.9687324797753407 -364,2018-08-17,-111.67500000000001,46.62500000000001,0.9687056483251796 -364,2018-08-18,-111.67500000000001,46.62500000000001,0.9686886332517379 -364,2018-08-19,-111.67500000000001,46.62500000000001,0.9686571955982594 -364,2018-08-20,-111.67500000000001,46.62500000000001,0.96864214959167 -364,2018-08-21,-111.67500000000001,46.62500000000001,0.9686397985740306 -364,2018-08-22,-111.67500000000001,46.62500000000001,0.9686371923192711 -364,2018-08-23,-111.67500000000001,46.62500000000001,0.9686178847644316 -364,2018-08-24,-111.67500000000001,46.62500000000001,0.9686007698022179 -364,2018-08-25,-111.67500000000001,46.62500000000001,0.968587152601525 -364,2018-08-26,-111.67500000000001,46.62500000000001,0.9685832724161049 -364,2018-08-27,-111.67500000000001,46.62500000000001,0.9685766034588966 -364,2018-08-28,-111.67500000000001,46.62500000000001,0.9685742524412573 -364,2018-08-29,-111.67500000000001,46.62500000000001,0.9685719014236178 -364,2018-08-30,-111.67500000000001,46.62500000000001,0.9685628361271756 -364,2018-08-31,-111.67500000000001,46.62500000000001,0.9685580260016201 -364,2018-09-01,-111.67500000000001,46.62500000000001,0.9685556749839807 -364,2018-09-02,-111.67500000000001,46.62500000000001,0.9685530019686055 -364,2018-09-03,-111.67500000000001,46.62500000000001,0.9685403222652179 -364,2018-09-04,-111.67500000000001,46.62500000000001,0.9685309804788298 -364,2018-09-05,-111.67500000000001,46.62500000000001,0.9685287765643261 -364,2018-09-06,-111.67500000000001,46.62500000000001,0.96852562320943 -364,2018-09-07,-111.67500000000001,46.62500000000001,0.9685207997606945 -364,2018-09-08,-111.67500000000001,46.62500000000001,0.9685153022405992 -364,2018-09-09,-111.67500000000001,46.62500000000001,0.9684989016846473 -364,2018-09-10,-111.67500000000001,46.62500000000001,0.9684928937937571 -364,2018-09-11,-111.67500000000001,46.62500000000001,0.9684871750722559 -364,2018-09-12,-111.67500000000001,46.62500000000001,0.968484825131552 -364,2018-09-13,-111.67500000000001,46.62500000000001,0.9684825310567315 -364,2018-09-14,-111.67500000000001,46.62500000000001,0.9684803271422279 -364,2018-09-15,-111.67500000000001,46.62500000000001,0.9684781232277242 -364,2018-09-16,-111.67500000000001,46.62500000000001,0.9684759193132206 -364,2018-09-17,-111.67500000000001,46.62500000000001,0.968473715398717 -364,2018-09-18,-111.67500000000001,46.62500000000001,0.9684715114842133 -364,2018-09-19,-111.67500000000001,46.62500000000001,0.9684693075697096 -364,2018-09-20,-111.67500000000001,46.62500000000001,0.9684671036552059 -364,2018-09-21,-111.67500000000001,46.62500000000001,0.9684648997407023 -364,2018-09-22,-111.67500000000001,46.62500000000001,0.9684626958261987 -364,2018-09-23,-111.67500000000001,46.62500000000001,0.968460491911695 -364,2018-09-24,-111.67500000000001,46.62500000000001,0.9684582879971914 -364,2018-09-25,-111.67500000000001,46.62500000000001,0.9684560840826877 -364,2018-09-26,-111.67500000000001,46.62500000000001,0.968453880168184 -364,2018-09-27,-111.67500000000001,46.62500000000001,0.9684516762536803 -364,2018-09-28,-111.67500000000001,46.62500000000001,0.9684494723391768 -364,2018-09-29,-111.67500000000001,46.62500000000001,0.9684472684246731 -364,2018-09-30,-111.67500000000001,46.62500000000001,0.9684450645101694 -364,2018-10-01,-111.67500000000001,46.62500000000001,0.9684428605956658 -364,2018-10-02,-111.67500000000001,46.62500000000001,0.968440936300077 -364,2018-10-03,-111.67500000000001,46.62500000000001,0.9684390120044883 -364,2018-10-04,-111.67500000000001,46.62500000000001,0.9684370877088996 -364,2018-10-05,-111.67500000000001,46.62500000000001,0.9684351634133108 -364,2018-10-06,-111.67500000000001,46.62500000000001,0.9684332391177222 -364,2018-10-07,-111.67500000000001,46.62500000000001,0.9684313148221334 -364,2018-10-08,-111.67500000000001,46.62500000000001,0.9684293905265446 -364,2018-10-09,-111.67500000000001,46.62500000000001,0.9684274662309559 -364,2018-10-10,-111.67500000000001,46.62500000000001,0.9684255419353672 -364,2018-10-11,-111.67500000000001,46.62500000000001,0.9684236176397785 -364,2018-10-12,-111.67500000000001,46.62500000000001,0.9684216933441897 -364,2018-10-13,-111.67500000000001,46.62500000000001,0.9684197690486009 -364,2018-10-14,-111.67500000000001,46.62500000000001,0.9684178447530123 -364,2018-10-15,-111.67500000000001,46.62500000000001,0.9684159204574235 -364,2018-10-16,-111.67500000000001,46.62500000000001,0.9684139961618348 -364,2018-10-17,-111.67500000000001,46.62500000000001,0.9684120718662461 -364,2018-10-18,-111.67500000000001,46.62500000000001,0.9684101475706574 -364,2018-10-19,-111.67500000000001,46.62500000000001,0.9684082232750686 -364,2018-10-20,-111.67500000000001,46.62500000000001,0.9684062989794798 -364,2018-10-21,-111.67500000000001,46.62500000000001,0.9684043746838912 -364,2018-10-22,-111.67500000000001,46.62500000000001,0.9684024503883024 -364,2018-10-23,-111.67500000000001,46.62500000000001,0.9684005260927137 -364,2018-10-24,-111.67500000000001,46.62500000000001,0.9683986017971249 -364,2018-10-25,-111.67500000000001,46.62500000000001,0.9683966775015362 -364,2018-10-26,-111.67500000000001,46.62500000000001,0.9683947532059475 -364,2018-10-27,-111.67500000000001,46.62500000000001,0.9683928289103587 -364,2018-10-28,-111.67500000000001,46.62500000000001,0.9683909046147701 -364,2018-10-29,-111.67500000000001,46.62500000000001,0.9683889803191813 -364,2018-10-30,-111.67500000000001,46.62500000000001,0.9683870560235925 -364,2018-10-31,-111.67500000000001,46.62500000000001,0.9683851317280038 -364,2018-11-01,-111.67500000000001,46.62500000000001,0.9683832074324151 -364,2018-11-02,-111.67500000000001,46.62500000000001,0.9683814267535692 -364,2018-11-03,-111.67500000000001,46.62500000000001,0.9683796460747234 -364,2018-11-04,-111.67500000000001,46.62500000000001,0.9683778653958776 -364,2018-11-05,-111.67500000000001,46.62500000000001,0.9683760847170317 -364,2018-11-06,-111.67500000000001,46.62500000000001,0.9683743040381859 -364,2018-11-07,-111.67500000000001,46.62500000000001,0.96837252335934 -364,2018-11-08,-111.67500000000001,46.62500000000001,0.9683707426804942 -364,2018-11-09,-111.67500000000001,46.62500000000001,0.9683689620016483 -364,2018-11-10,-111.67500000000001,46.62500000000001,0.9683671813228025 -364,2018-11-11,-111.67500000000001,46.62500000000001,0.9683654006439567 -364,2018-11-12,-111.67500000000001,46.62500000000001,0.9683636199651108 -364,2018-11-13,-111.67500000000001,46.62500000000001,0.968361839286265 -364,2018-11-14,-111.67500000000001,46.62500000000001,0.9683600586074191 -364,2018-11-15,-111.67500000000001,46.62500000000001,0.9683582779285733 -364,2018-11-16,-111.67500000000001,46.62500000000001,0.9683564972497275 -364,2018-11-17,-111.67500000000001,46.62500000000001,0.9683547165708816 -364,2018-11-18,-111.67500000000001,46.62500000000001,0.9683529358920357 -364,2018-11-19,-111.67500000000001,46.62500000000001,0.9683511552131899 -364,2018-11-20,-111.67500000000001,46.62500000000001,0.9683493745343441 -364,2018-11-21,-111.67500000000001,46.62500000000001,0.9683475938554983 -364,2018-11-22,-111.67500000000001,46.62500000000001,0.9683458131766524 -364,2018-11-23,-111.67500000000001,46.62500000000001,0.9683440324978065 -364,2018-11-24,-111.67500000000001,46.62500000000001,0.9683422518189607 -364,2018-11-25,-111.67500000000001,46.62500000000001,0.9683404711401149 -364,2018-11-26,-111.67500000000001,46.62500000000001,0.968338690461269 -364,2018-11-27,-111.67500000000001,46.62500000000001,0.9683369097824231 -364,2018-11-28,-111.67500000000001,46.62500000000001,0.9683351291035773 -364,2018-11-29,-111.67500000000001,46.62500000000001,0.9683333484247315 -364,2018-11-30,-111.67500000000001,46.62500000000001,0.9683315677458857 -364,2018-12-01,-111.67500000000001,46.62500000000001,0.9683297870670398 -364,2018-12-02,-111.67500000000001,46.62500000000001,0.9683281629410603 -364,2018-12-03,-111.67500000000001,46.62500000000001,0.9683265388150807 -364,2018-12-04,-111.67500000000001,46.62500000000001,0.9683249146891012 -364,2018-12-05,-111.67500000000001,46.62500000000001,0.9683232905631216 -364,2018-12-06,-111.67500000000001,46.62500000000001,0.9683216664371421 -364,2018-12-07,-111.67500000000001,46.62500000000001,0.9683200423111625 -364,2018-12-08,-111.67500000000001,46.62500000000001,0.968318418185183 -364,2018-12-09,-111.67500000000001,46.62500000000001,0.9683167940592035 -364,2018-12-10,-111.67500000000001,46.62500000000001,0.968315169933224 -364,2018-12-11,-111.67500000000001,46.62500000000001,0.9683135458072444 -364,2018-12-12,-111.67500000000001,46.62500000000001,0.9683119216812648 -364,2018-12-13,-111.67500000000001,46.62500000000001,0.9683102975552853 -364,2018-12-14,-111.67500000000001,46.62500000000001,0.9683086734293057 -364,2018-12-15,-111.67500000000001,46.62500000000001,0.9683070493033262 -364,2018-12-16,-111.67500000000001,46.62500000000001,0.9683054251773466 -364,2018-12-17,-111.67500000000001,46.62500000000001,0.9683038010513672 -364,2018-12-18,-111.67500000000001,46.62500000000001,0.9683021769253876 -364,2018-12-19,-111.67500000000001,46.62500000000001,0.9683005527994081 -364,2018-12-20,-111.67500000000001,46.62500000000001,0.9682989286734285 -364,2018-12-21,-111.67500000000001,46.62500000000001,0.968297304547449 -364,2018-12-22,-111.67500000000001,46.62500000000001,0.9682956804214694 -364,2018-12-23,-111.67500000000001,46.62500000000001,0.9682940562954898 -364,2018-12-24,-111.67500000000001,46.62500000000001,0.9682924321695103 -364,2018-12-25,-111.67500000000001,46.62500000000001,0.9682908080435307 -364,2018-12-26,-111.67500000000001,46.62500000000001,0.9682891839175513 -364,2018-12-27,-111.67500000000001,46.62500000000001,0.9682875597915717 -364,2018-12-28,-111.67500000000001,46.62500000000001,0.9682859356655922 -364,2018-12-29,-111.67500000000001,46.62500000000001,0.9682843115396126 -364,2018-12-30,-111.67500000000001,46.62500000000001,0.9682826874136331 -364,2018-12-31,-111.67500000000001,46.62500000000001,0.9682810632876535 -364,2019-01-01,-111.67500000000001,46.62500000000001,0.968279439161674 -364,2019-01-02,-111.67500000000001,46.62500000000001,0.9682777596007993 -364,2019-01-03,-111.67500000000001,46.62500000000001,0.9682760800399246 -364,2019-01-04,-111.67500000000001,46.62500000000001,0.9682744004790499 -364,2019-01-05,-111.67500000000001,46.62500000000001,0.9682727209181752 -364,2019-01-06,-111.67500000000001,46.62500000000001,0.9682710413573005 -364,2019-01-07,-111.67500000000001,46.62500000000001,0.9682693617964255 -364,2019-01-08,-111.67500000000001,46.62500000000001,0.9682676822355509 -364,2019-01-09,-111.67500000000001,46.62500000000001,0.9682660026746762 -364,2019-01-10,-111.67500000000001,46.62500000000001,0.9682643231138015 -364,2019-01-11,-111.67500000000001,46.62500000000001,0.9682626435529268 -364,2019-01-12,-111.67500000000001,46.62500000000001,0.9682609639920521 -364,2019-01-13,-111.67500000000001,46.62500000000001,0.9682592844311774 -364,2019-01-14,-111.67500000000001,46.62500000000001,0.9682576048703027 -364,2019-01-15,-111.67500000000001,46.62500000000001,0.968255925309428 -364,2019-01-16,-111.67500000000001,46.62500000000001,0.9682542457485532 -364,2019-01-17,-111.67500000000001,46.62500000000001,0.9682525661876785 -364,2019-01-18,-111.67500000000001,46.62500000000001,0.9682508866268039 -364,2019-01-19,-111.67500000000001,46.62500000000001,0.9682492070659292 -364,2019-01-20,-111.67500000000001,46.62500000000001,0.9682475275050545 -364,2019-01-21,-111.67500000000001,46.62500000000001,0.9682458479441798 -364,2019-01-22,-111.67500000000001,46.62500000000001,0.9682441683833051 -364,2019-01-23,-111.67500000000001,46.62500000000001,0.9682424888224304 -364,2019-01-24,-111.67500000000001,46.62500000000001,0.9682408092615556 -364,2019-01-25,-111.67500000000001,46.62500000000001,0.9682391297006809 -364,2019-01-26,-111.67500000000001,46.62500000000001,0.9682374501398062 -364,2019-01-27,-111.67500000000001,46.62500000000001,0.9682357705789316 -364,2019-01-28,-111.67500000000001,46.62500000000001,0.9682340910180569 -364,2019-01-29,-111.67500000000001,46.62500000000001,0.9682324114571822 -364,2019-01-30,-111.67500000000001,46.62500000000001,0.9682307318963075 -364,2019-01-31,-111.67500000000001,46.62500000000001,0.9682290523354328 -364,2019-02-01,-111.67500000000001,46.62500000000001,0.9682273727745581 -364,2019-02-02,-111.67500000000001,46.62500000000001,0.9682259188359524 -364,2019-02-03,-111.67500000000001,46.62500000000001,0.9682244648973469 -364,2019-02-04,-111.67500000000001,46.62500000000001,0.9682230109587413 -364,2019-02-05,-111.67500000000001,46.62500000000001,0.9682215570201357 -364,2019-02-06,-111.67500000000001,46.62500000000001,0.9682201030815302 -364,2019-02-07,-111.67500000000001,46.62500000000001,0.9682186491429245 -364,2019-02-08,-111.67500000000001,46.62500000000001,0.9682171952043189 -364,2019-02-09,-111.67500000000001,46.62500000000001,0.9682157412657134 -364,2019-02-10,-111.67500000000001,46.62500000000001,0.9682142873271078 -364,2019-02-11,-111.67500000000001,46.62500000000001,0.9682128333885022 -364,2019-02-12,-111.67500000000001,46.62500000000001,0.9682113794498967 -364,2019-02-13,-111.67500000000001,46.62500000000001,0.968209925511291 -364,2019-02-14,-111.67500000000001,46.62500000000001,0.9682084715726854 -364,2019-02-15,-111.67500000000001,46.62500000000001,0.9682070176340799 -364,2019-02-16,-111.67500000000001,46.62500000000001,0.9682055636954743 -364,2019-02-17,-111.67500000000001,46.62500000000001,0.9682041097568687 -364,2019-02-18,-111.67500000000001,46.62500000000001,0.9682026558182631 -364,2019-02-19,-111.67500000000001,46.62500000000001,0.9682012018796575 -364,2019-02-20,-111.67500000000001,46.62500000000001,0.9681997479410519 -364,2019-02-21,-111.67500000000001,46.62500000000001,0.9681982940024463 -364,2019-02-22,-111.67500000000001,46.62500000000001,0.9681968400638408 -364,2019-02-23,-111.67500000000001,46.62500000000001,0.9681953861252351 -364,2019-02-24,-111.67500000000001,46.62500000000001,0.9681939321866295 -364,2019-02-25,-111.67500000000001,46.62500000000001,0.968192478248024 -364,2019-02-26,-111.67500000000001,46.62500000000001,0.9681910243094184 -364,2019-02-27,-111.67500000000001,46.62500000000001,0.9681895703708128 -364,2019-02-28,-111.67500000000001,46.62500000000001,0.9681881164322073 -364,2019-03-01,-111.67500000000001,46.62500000000001,0.9681866624936016 -364,2019-03-02,-111.67500000000001,46.62500000000001,0.96818503764226 -364,2019-03-03,-111.67500000000001,46.62500000000001,0.9681834127909184 -364,2019-03-04,-111.67500000000001,46.62500000000001,0.9681817879395767 -364,2019-03-05,-111.67500000000001,46.62500000000001,0.9681801630882351 -364,2019-03-06,-111.67500000000001,46.62500000000001,0.9681785382368934 -364,2019-03-07,-111.67500000000001,46.62500000000001,0.9681769133855518 -364,2019-03-08,-111.67500000000001,46.62500000000001,0.9681752885342101 -364,2019-03-09,-111.67500000000001,46.62500000000001,0.9681736636828685 -364,2019-03-10,-111.67500000000001,46.62500000000001,0.9681720388315268 -364,2019-03-11,-111.67500000000001,46.62500000000001,0.9681704139801852 -364,2019-03-12,-111.67500000000001,46.62500000000001,0.9681687891288435 -364,2019-03-13,-111.67500000000001,46.62500000000001,0.9681671642775019 -364,2019-03-14,-111.67500000000001,46.62500000000001,0.9681655394261602 -364,2019-03-15,-111.67500000000001,46.62500000000001,0.9681639145748187 -364,2019-03-16,-111.67500000000001,46.62500000000001,0.968162289723477 -364,2019-03-17,-111.67500000000001,46.62500000000001,0.9681606648721354 -364,2019-03-18,-111.67500000000001,46.62500000000001,0.9681590400207937 -364,2019-03-19,-111.67500000000001,46.62500000000001,0.9681574151694521 -364,2019-03-20,-111.67500000000001,46.62500000000001,0.9681557903181104 -364,2019-03-21,-111.67500000000001,46.62500000000001,0.9681541654667687 -364,2019-03-22,-111.67500000000001,46.62500000000001,0.9681525406154271 -364,2019-03-23,-111.67500000000001,46.62500000000001,0.9681509157640854 -364,2019-03-24,-111.67500000000001,46.62500000000001,0.9681492909127438 -364,2019-03-25,-111.67500000000001,46.62500000000001,0.9681476660614021 -364,2019-03-26,-111.67500000000001,46.62500000000001,0.9681460412100605 -364,2019-03-27,-111.67500000000001,46.62500000000001,0.9681444163587188 -364,2019-03-28,-111.67500000000001,46.62500000000001,0.9681427915073773 -364,2019-03-29,-111.67500000000001,46.62500000000001,0.9681411666560356 -364,2019-03-30,-111.67500000000001,46.62500000000001,0.968139541804694 -364,2019-03-31,-111.67500000000001,46.62500000000001,0.9681379169533523 -364,2019-04-01,-111.67500000000001,46.62500000000001,0.9681362921020107 -364,2019-04-02,-111.67500000000001,46.62500000000001,0.9681342942535222 -364,2019-04-03,-111.67500000000001,46.62500000000001,0.9681322964050336 -364,2019-04-04,-111.67500000000001,46.62500000000001,0.9681302985565452 -364,2019-04-05,-111.67500000000001,46.62500000000001,0.9681283007080567 -364,2019-04-06,-111.67500000000001,46.62500000000001,0.9681263028595682 -364,2019-04-07,-111.67500000000001,46.62500000000001,0.9681243050110797 -364,2019-04-08,-111.67500000000001,46.62500000000001,0.9681223071625912 -364,2019-04-09,-111.67500000000001,46.62500000000001,0.9678979616285255 -364,2019-04-10,-111.67500000000001,46.62500000000001,0.9674819863694181 -364,2019-04-11,-111.67500000000001,46.62500000000001,0.9685958436762726 -364,2019-04-12,-111.67500000000001,46.62500000000001,0.9717017883203893 -364,2019-04-13,-111.67500000000001,46.62500000000001,0.9763732927048459 -364,2019-04-14,-111.67500000000001,46.62500000000001,0.9810324207094874 -364,2019-04-15,-111.67500000000001,46.62500000000001,0.9848052651890244 -364,2019-04-16,-111.67500000000001,46.62500000000001,0.9874693014864719 -364,2019-04-17,-111.67500000000001,46.62500000000001,0.9883979338572401 -364,2019-04-18,-111.67500000000001,46.62500000000001,0.9885581807364165 -364,2019-04-19,-111.67500000000001,46.62500000000001,0.9884454481716934 -364,2019-04-20,-111.67500000000001,46.62500000000001,0.9882517835337158 -364,2019-04-21,-111.67500000000001,46.62500000000001,0.9881555156218524 -364,2019-04-22,-111.67500000000001,46.62500000000001,0.9884932094618778 -364,2019-04-23,-111.67500000000001,46.62500000000001,0.9895960565871108 -364,2019-04-24,-111.67500000000001,46.62500000000001,0.991311564682792 -364,2019-04-25,-111.67500000000001,46.62500000000001,0.9925127162168089 -364,2019-04-26,-111.67500000000001,46.62500000000001,0.9929909179914185 -364,2019-04-27,-111.67500000000001,46.62500000000001,0.9932766736639586 -364,2019-04-28,-111.67500000000001,46.62500000000001,0.9933955651925389 -364,2019-04-29,-111.67500000000001,46.62500000000001,0.9933416311540503 -364,2019-04-30,-111.67500000000001,46.62500000000001,0.9931198252840797 -364,2019-05-01,-111.67500000000001,46.62500000000001,0.9925900674737217 -364,2019-05-02,-111.67500000000001,46.62500000000001,0.991827948710517 -364,2019-05-03,-111.67500000000001,46.62500000000001,0.9909938308664288 -364,2019-05-04,-111.67500000000001,46.62500000000001,0.9901964404599166 -364,2019-05-05,-111.67500000000001,46.62500000000001,0.9894848611708686 -364,2019-05-06,-111.67500000000001,46.62500000000001,0.9888822242378466 -364,2019-05-07,-111.67500000000001,46.62500000000001,0.988462933401519 -364,2019-05-08,-111.67500000000001,46.62500000000001,0.9882942668773583 -364,2019-05-09,-111.67500000000001,46.62500000000001,0.9882738332094787 -364,2019-05-10,-111.67500000000001,46.62500000000001,0.9882880724086827 -364,2019-05-11,-111.67500000000001,46.62500000000001,0.9883191505465814 -364,2019-05-12,-111.67500000000001,46.62500000000001,0.9882724501068298 -364,2019-05-13,-111.67500000000001,46.62500000000001,0.9880411796706173 -364,2019-05-14,-111.67500000000001,46.62500000000001,0.9877212897757696 -364,2019-05-15,-111.67500000000001,46.62500000000001,0.987532333579037 -364,2019-05-16,-111.67500000000001,46.62500000000001,0.9876923254587064 -364,2019-05-17,-111.67500000000001,46.62500000000001,0.9882146048039941 -364,2019-05-18,-111.67500000000001,46.62500000000001,0.9890408889456643 -364,2019-05-19,-111.67500000000001,46.62500000000001,0.9899034809783565 -364,2019-05-20,-111.67500000000001,46.62500000000001,0.9906318828442381 -364,2019-05-21,-111.67500000000001,46.62500000000001,0.9911834320823417 -364,2019-05-22,-111.67500000000001,46.62500000000001,0.9913393820977556 -364,2019-05-23,-111.67500000000001,46.62500000000001,0.9911015944730913 -364,2019-05-24,-111.67500000000001,46.62500000000001,0.9907425418231484 -364,2019-05-25,-111.67500000000001,46.62500000000001,0.9904347121087934 -364,2019-05-26,-111.67500000000001,46.62500000000001,0.9901232919209599 -364,2019-05-27,-111.67500000000001,46.62500000000001,0.989885716652377 -364,2019-05-28,-111.67500000000001,46.62500000000001,0.9898619579728936 -364,2019-05-29,-111.67500000000001,46.62500000000001,0.9900505389687295 -364,2019-05-30,-111.67500000000001,46.62500000000001,0.9903549518034319 -364,2019-05-31,-111.67500000000001,46.62500000000001,0.9906671991341051 -364,2019-06-01,-111.67500000000001,46.62500000000001,0.9908843001470016 -364,2019-06-02,-111.67500000000001,46.62500000000001,0.9909638403037805 -364,2019-06-03,-111.67500000000001,46.62500000000001,0.9910795295878287 -364,2019-06-04,-111.67500000000001,46.62500000000001,0.9912910194145316 -364,2019-06-05,-111.67500000000001,46.62500000000001,0.9916437318780283 -364,2019-06-06,-111.67500000000001,46.62500000000001,0.9920913378300649 -364,2019-06-07,-111.67500000000001,46.62500000000001,0.9925400174317429 -364,2019-06-08,-111.67500000000001,46.62500000000001,0.9931362552603028 -364,2019-06-09,-111.67500000000001,46.62500000000001,0.9935283519704843 -364,2019-06-10,-111.67500000000001,46.62500000000001,0.9936170532746588 -364,2019-06-11,-111.67500000000001,46.62500000000001,0.9935844715637792 -364,2019-06-12,-111.67500000000001,46.62500000000001,0.9932664635282576 -364,2019-06-13,-111.67500000000001,46.62500000000001,0.9927638700315614 -364,2019-06-14,-111.67500000000001,46.62500000000001,0.9923040863202321 -364,2019-06-15,-111.67500000000001,46.62500000000001,0.9919458221368704 -364,2019-06-16,-111.67500000000001,46.62500000000001,0.9916508903332275 -364,2019-06-17,-111.67500000000001,46.62500000000001,0.991356614627915 -364,2019-06-18,-111.67500000000001,46.62500000000001,0.9910261370645355 -364,2019-06-19,-111.67500000000001,46.62500000000001,0.9907574933671878 -364,2019-06-20,-111.67500000000001,46.62500000000001,0.9905603565091489 -364,2019-06-21,-111.67500000000001,46.62500000000001,0.9903232601321373 -364,2019-06-22,-111.67500000000001,46.62500000000001,0.9900662255019342 -364,2019-06-23,-111.67500000000001,46.62500000000001,0.9898727632886354 -364,2019-06-24,-111.67500000000001,46.62500000000001,0.9896825118753477 -364,2019-06-25,-111.67500000000001,46.62500000000001,0.9894541754551828 -364,2019-06-26,-111.67500000000001,46.62500000000001,0.9892202052003978 -364,2019-06-27,-111.67500000000001,46.62500000000001,0.9889805351452031 -364,2019-06-28,-111.67500000000001,46.62500000000001,0.9887446942325979 -364,2019-06-29,-111.67500000000001,46.62500000000001,0.9885020214742919 -364,2019-06-30,-111.67500000000001,46.62500000000001,0.9882707774419631 -364,2019-07-01,-111.67500000000001,46.62500000000001,0.9880245912757033 -364,2019-07-02,-111.67500000000001,46.62500000000001,0.9877144499758805 -364,2019-07-03,-111.67500000000001,46.62500000000001,0.9873874490501576 -364,2019-07-04,-111.67500000000001,46.62500000000001,0.9871648620411309 -364,2019-07-05,-111.67500000000001,46.62500000000001,0.9869986598430572 -364,2019-07-06,-111.67500000000001,46.62500000000001,0.9868149145703152 -364,2019-07-07,-111.67500000000001,46.62500000000001,0.9867159575822556 -364,2019-07-08,-111.67500000000001,46.62500000000001,0.9866209922871169 -364,2019-07-09,-111.67500000000001,46.62500000000001,0.9863867079362036 -364,2019-07-10,-111.67500000000001,46.62500000000001,0.9859557769358178 -364,2019-07-11,-111.67500000000001,46.62500000000001,0.9853882046449532 -364,2019-07-12,-111.67500000000001,46.62500000000001,0.9847264785558486 -364,2019-07-13,-111.67500000000001,46.62500000000001,0.983849703926064 -364,2019-07-14,-111.67500000000001,46.62500000000001,0.982690542477266 -364,2019-07-15,-111.67500000000001,46.62500000000001,0.981335257507113 -364,2019-07-16,-111.67500000000001,46.62500000000001,0.9799334587607517 -364,2019-07-17,-111.67500000000001,46.62500000000001,0.9785642098241483 -364,2019-07-18,-111.67500000000001,46.62500000000001,0.977197149166682 -364,2019-07-19,-111.67500000000001,46.62500000000001,0.9758057593078472 -364,2019-07-20,-111.67500000000001,46.62500000000001,0.9744100849994985 -364,2019-07-21,-111.67500000000001,46.62500000000001,0.9730402170758957 -364,2019-07-22,-111.67500000000001,46.62500000000001,0.9717223684270541 -364,2019-07-23,-111.67500000000001,46.62500000000001,0.9704444368566372 -364,2019-07-24,-111.67500000000001,46.62500000000001,0.9692006060876656 -364,2019-07-25,-111.67500000000001,46.62500000000001,0.9689757271702559 -364,2019-07-26,-111.67500000000001,46.62500000000001,0.9689331697833932 -364,2019-07-27,-111.67500000000001,46.62500000000001,0.9689101210876204 -364,2019-07-28,-111.67500000000001,46.62500000000001,0.9688703523619979 -364,2019-07-29,-111.67500000000001,46.62500000000001,0.9688366154789386 -364,2019-07-30,-111.67500000000001,46.62500000000001,0.968799877189224 -364,2019-07-31,-111.67500000000001,46.62500000000001,0.9687712232958522 -364,2019-08-01,-111.67500000000001,46.62500000000001,0.9687417867078291 -364,2019-08-02,-111.67500000000001,46.62500000000001,0.9687101314188303 -364,2019-08-03,-111.67500000000001,46.62500000000001,0.9686751751397079 -364,2019-08-04,-111.67500000000001,46.62500000000001,0.968639670170845 -364,2019-08-05,-111.67500000000001,46.62500000000001,0.9686083196898725 -364,2019-08-06,-111.67500000000001,46.62500000000001,0.9685849749630336 -364,2019-08-07,-111.67500000000001,46.62500000000001,0.968566904814351 -364,2019-08-08,-111.67500000000001,46.62500000000001,0.9685524306785825 -364,2019-08-09,-111.67500000000001,46.62500000000001,0.968515177183576 -364,2019-08-10,-111.67500000000001,46.62500000000001,0.9685007879798366 -364,2019-08-11,-111.67500000000001,46.62500000000001,0.9684984664378125 -364,2019-08-12,-111.67500000000001,46.62500000000001,0.9684961448957883 -364,2019-08-13,-111.67500000000001,46.62500000000001,0.9684937805659225 -364,2019-08-14,-111.67500000000001,46.62500000000001,0.9684913716368874 -364,2019-08-15,-111.67500000000001,46.62500000000001,0.9684856426786601 -364,2019-08-16,-111.67500000000001,46.62500000000001,0.9684581479464082 -364,2019-08-17,-111.67500000000001,46.62500000000001,0.9684351765002086 -364,2019-08-18,-111.67500000000001,46.62500000000001,0.9684328549581843 -364,2019-08-19,-111.67500000000001,46.62500000000001,0.9684266081729557 -364,2019-08-20,-111.67500000000001,46.62500000000001,0.9684193770269499 -364,2019-08-21,-111.67500000000001,46.62500000000001,0.9684143681920115 -364,2019-08-22,-111.67500000000001,46.62500000000001,0.9684050088160737 -364,2019-08-23,-111.67500000000001,46.62500000000001,0.9684021611735976 -364,2019-08-24,-111.67500000000001,46.62500000000001,0.9683998391225419 -364,2019-08-25,-111.67500000000001,46.62500000000001,0.9683962015853566 -364,2019-08-26,-111.67500000000001,46.62500000000001,0.9683890443573294 -364,2019-08-27,-111.67500000000001,46.62500000000001,0.9683867110303463 -364,2019-08-28,-111.67500000000001,46.62500000000001,0.9683843894881111 -364,2019-08-29,-111.67500000000001,46.62500000000001,0.9683757644469301 -364,2019-08-30,-111.67500000000001,46.62500000000001,0.9683734429049059 -364,2019-08-31,-111.67500000000001,46.62500000000001,0.9683711212557564 -364,2019-09-01,-111.67500000000001,46.62500000000001,0.9683518167904137 -364,2019-09-02,-111.67500000000001,46.62500000000001,0.9683493781871247 -364,2019-09-03,-111.67500000000001,46.62500000000001,0.9683363588921066 -364,2019-09-04,-111.67500000000001,46.62500000000001,0.968328774827567 -364,2019-09-05,-111.67500000000001,46.62500000000001,0.9683157177999848 -364,2019-09-06,-111.67500000000001,46.62500000000001,0.968300293233255 -364,2019-09-07,-111.67500000000001,46.62500000000001,0.9682980424424456 -364,2019-09-08,-111.67500000000001,46.62500000000001,0.9682957973765421 -364,2019-09-09,-111.67500000000001,46.62500000000001,0.9682935523106386 -364,2019-09-10,-111.67500000000001,46.62500000000001,0.9682913072447351 -364,2019-09-11,-111.67500000000001,46.62500000000001,0.9682890621788317 -364,2019-09-12,-111.67500000000001,46.62500000000001,0.9682868171129282 -364,2019-09-13,-111.67500000000001,46.62500000000001,0.9682845720470248 -364,2019-09-14,-111.67500000000001,46.62500000000001,0.9682823269811213 -364,2019-09-15,-111.67500000000001,46.62500000000001,0.9682800819152179 -364,2019-09-16,-111.67500000000001,46.62500000000001,0.9682758413536195 -364,2019-09-17,-111.67500000000001,46.62500000000001,0.9682735960979638 -364,2019-09-18,-111.67500000000001,46.62500000000001,0.9682713510320604 -364,2019-09-19,-111.67500000000001,46.62500000000001,0.9682691059661569 -364,2019-09-20,-111.67500000000001,46.62500000000001,0.9682668609002535 -364,2019-09-21,-111.67500000000001,46.62500000000001,0.96826461583435 -364,2019-09-22,-111.67500000000001,46.62500000000001,0.9682623707684466 -364,2019-09-23,-111.67500000000001,46.62500000000001,0.9682601227610977 -364,2019-09-24,-111.67500000000001,46.62500000000001,0.9682578738327122 -364,2019-09-25,-111.67500000000001,46.62500000000001,0.9682544181056099 -364,2019-09-26,-111.67500000000001,46.62500000000001,0.9682520071622545 -364,2019-09-27,-111.67500000000001,46.62500000000001,0.9682497620963509 -364,2019-09-28,-111.67500000000001,46.62500000000001,0.9682475170304475 -364,2019-09-29,-111.67500000000001,46.62500000000001,0.968245271964544 -364,2019-09-30,-111.67500000000001,46.62500000000001,0.9682430268986406 -364,2019-10-01,-111.67500000000001,46.62500000000001,0.9682407818327371 -364,2019-10-02,-111.67500000000001,46.62500000000001,0.9682389587612437 -364,2019-10-03,-111.67500000000001,46.62500000000001,0.9682371356897501 -364,2019-10-04,-111.67500000000001,46.62500000000001,0.9682353126182566 -364,2019-10-05,-111.67500000000001,46.62500000000001,0.9682334895467631 -364,2019-10-06,-111.67500000000001,46.62500000000001,0.9682316664752696 -364,2019-10-07,-111.67500000000001,46.62500000000001,0.968229843403776 -364,2019-10-08,-111.67500000000001,46.62500000000001,0.9682280203322826 -364,2019-10-09,-111.67500000000001,46.62500000000001,0.9682261972607891 -364,2019-10-10,-111.67500000000001,46.62500000000001,0.9682243741892955 -364,2019-10-11,-111.67500000000001,46.62500000000001,0.9682225511178021 -364,2019-10-12,-111.67500000000001,46.62500000000001,0.9682207280463085 -364,2019-10-13,-111.67500000000001,46.62500000000001,0.968218904974815 -364,2019-10-14,-111.67500000000001,46.62500000000001,0.9682170819033216 -364,2019-10-15,-111.67500000000001,46.62500000000001,0.968215258831828 -364,2019-10-16,-111.67500000000001,46.62500000000001,0.9682134357603346 -364,2019-10-17,-111.67500000000001,46.62500000000001,0.968211612688841 -364,2019-10-18,-111.67500000000001,46.62500000000001,0.9682097896173475 -364,2019-10-19,-111.67500000000001,46.62500000000001,0.9682079665458541 -364,2019-10-20,-111.67500000000001,46.62500000000001,0.9682061434743605 -364,2019-10-21,-111.67500000000001,46.62500000000001,0.968204320402867 -364,2019-10-22,-111.67500000000001,46.62500000000001,0.9682024973313735 -364,2019-10-23,-111.67500000000001,46.62500000000001,0.96820067425988 -364,2019-10-24,-111.67500000000001,46.62500000000001,0.9681988511883864 -364,2019-10-25,-111.67500000000001,46.62500000000001,0.968197028116893 -364,2019-10-26,-111.67500000000001,46.62500000000001,0.9681952050453995 -364,2019-10-27,-111.67500000000001,46.62500000000001,0.9681933819739059 -364,2019-10-28,-111.67500000000001,46.62500000000001,0.9681915589024125 -364,2019-10-29,-111.67500000000001,46.62500000000001,0.9681897358309189 -364,2019-10-30,-111.67500000000001,46.62500000000001,0.9681879127594254 -364,2019-10-31,-111.67500000000001,46.62500000000001,0.968186089687932 -364,2019-11-01,-111.67500000000001,46.62500000000001,0.9681842666164384 -364,2019-11-02,-111.67500000000001,46.62500000000001,0.9681824480289177 -364,2019-11-03,-111.67500000000001,46.62500000000001,0.968180629441397 -364,2019-11-04,-111.67500000000001,46.62500000000001,0.9681788108538762 -364,2019-11-05,-111.67500000000001,46.62500000000001,0.9681769922663556 -364,2019-11-06,-111.67500000000001,46.62500000000001,0.9681751736788349 -364,2019-11-07,-111.67500000000001,46.62500000000001,0.9681733550913141 -364,2019-11-08,-111.67500000000001,46.62500000000001,0.9681715365037934 -364,2019-11-09,-111.67500000000001,46.62500000000001,0.9681697179162727 -364,2019-11-10,-111.67500000000001,46.62500000000001,0.9681678993287519 -364,2019-11-11,-111.67500000000001,46.62500000000001,0.9681660807412312 -364,2019-11-12,-111.67500000000001,46.62500000000001,0.9681642621537105 -364,2019-11-13,-111.67500000000001,46.62500000000001,0.9681624435661899 -364,2019-11-14,-111.67500000000001,46.62500000000001,0.9681606249786691 -364,2019-11-15,-111.67500000000001,46.62500000000001,0.9681588063911484 -364,2019-11-16,-111.67500000000001,46.62500000000001,0.9681569878036277 -364,2019-11-17,-111.67500000000001,46.62500000000001,0.9681551692161069 -364,2019-11-18,-111.67500000000001,46.62500000000001,0.9681533506285862 -364,2019-11-19,-111.67500000000001,46.62500000000001,0.9681515320410655 -364,2019-11-20,-111.67500000000001,46.62500000000001,0.9681497134535447 -364,2019-11-21,-111.67500000000001,46.62500000000001,0.968147894866024 -364,2019-11-22,-111.67500000000001,46.62500000000001,0.9681460762785034 -364,2019-11-23,-111.67500000000001,46.62500000000001,0.9681442576909827 -364,2019-11-24,-111.67500000000001,46.62500000000001,0.9681424391034619 -364,2019-11-25,-111.67500000000001,46.62500000000001,0.9681406205159412 -364,2019-11-26,-111.67500000000001,46.62500000000001,0.9681388019284205 -364,2019-11-27,-111.67500000000001,46.62500000000001,0.9681369833408997 -364,2019-11-28,-111.67500000000001,46.62500000000001,0.968135164753379 -364,2019-11-29,-111.67500000000001,46.62500000000001,0.9681333461658583 -364,2019-11-30,-111.67500000000001,46.62500000000001,0.9681315275783375 -364,2019-12-01,-111.67500000000001,46.62500000000001,0.9681297089908169 -364,2019-12-02,-111.67500000000001,46.62500000000001,0.9681279881197791 -364,2019-12-03,-111.67500000000001,46.62500000000001,0.9681262672487412 -364,2019-12-04,-111.67500000000001,46.62500000000001,0.9681245463777034 -364,2019-12-05,-111.67500000000001,46.62500000000001,0.9681228255066655 -364,2019-12-06,-111.67500000000001,46.62500000000001,0.9681211046356276 -364,2019-12-07,-111.67500000000001,46.62500000000001,0.9681193837645898 -364,2019-12-08,-111.67500000000001,46.62500000000001,0.968117662893552 -364,2019-12-09,-111.67500000000001,46.62500000000001,0.9681159420225142 -364,2019-12-10,-111.67500000000001,46.62500000000001,0.9681142211514763 -364,2019-12-11,-111.67500000000001,46.62500000000001,0.9681125002804385 -364,2019-12-12,-111.67500000000001,46.62500000000001,0.9681107794094006 -364,2019-12-13,-111.67500000000001,46.62500000000001,0.9681090585383628 -364,2019-12-14,-111.67500000000001,46.62500000000001,0.9681073376673249 -364,2019-12-15,-111.67500000000001,46.62500000000001,0.9681056167962871 -364,2019-12-16,-111.67500000000001,46.62500000000001,0.9681038959252493 -364,2019-12-17,-111.67500000000001,46.62500000000001,0.9681021750542114 -364,2019-12-18,-111.67500000000001,46.62500000000001,0.9681004541831736 -364,2019-12-19,-111.67500000000001,46.62500000000001,0.9680987333121357 -364,2019-12-20,-111.67500000000001,46.62500000000001,0.9680970124410979 -364,2019-12-21,-111.67500000000001,46.62500000000001,0.96809529157006 -364,2019-12-22,-111.67500000000001,46.62500000000001,0.9680935706990222 -364,2019-12-23,-111.67500000000001,46.62500000000001,0.9680918498279844 -364,2019-12-24,-111.67500000000001,46.62500000000001,0.9680901289569466 -364,2019-12-25,-111.67500000000001,46.62500000000001,0.9680884080859087 -364,2019-12-26,-111.67500000000001,46.62500000000001,0.9680866872148709 -364,2019-12-27,-111.67500000000001,46.62500000000001,0.968084966343833 -364,2019-12-28,-111.67500000000001,46.62500000000001,0.9680832454727951 -364,2019-12-29,-111.67500000000001,46.62500000000001,0.9680815246017573 -364,2019-12-30,-111.67500000000001,46.62500000000001,0.9680798037307194 -364,2019-12-31,-111.67500000000001,46.62500000000001,0.9680780828596817 -364,2020-01-01,-111.67500000000001,46.62500000000001,0.9680763619886438 -609,2018-01-02,-106.37500000000001,47.975,0.9697878046528535 -609,2018-01-03,-106.37500000000001,47.975,0.9697877882682735 -609,2018-01-04,-106.37500000000001,47.975,0.9697877718836935 -609,2018-01-05,-106.37500000000001,47.975,0.9697877554991133 -609,2018-01-06,-106.37500000000001,47.975,0.9697877391145333 -609,2018-01-07,-106.37500000000001,47.975,0.9697877227299532 -609,2018-01-08,-106.37500000000001,47.975,0.9697877063453731 -609,2018-01-09,-106.37500000000001,47.975,0.9697876899607931 -609,2018-01-10,-106.37500000000001,47.975,0.969787673576213 -609,2018-01-11,-106.37500000000001,47.975,0.969787657191633 -609,2018-01-12,-106.37500000000001,47.975,0.9697876408070528 -609,2018-01-13,-106.37500000000001,47.975,0.9697876244224728 -609,2018-01-14,-106.37500000000001,47.975,0.9697876080378928 -609,2018-01-15,-106.37500000000001,47.975,0.9697875916533126 -609,2018-01-16,-106.37500000000001,47.975,0.9697875752687326 -609,2018-01-17,-106.37500000000001,47.975,0.9697875588841525 -609,2018-01-18,-106.37500000000001,47.975,0.9697875424995724 -609,2018-01-19,-106.37500000000001,47.975,0.9697875261149924 -609,2018-01-20,-106.37500000000001,47.975,0.9697875097304123 -609,2018-01-21,-106.37500000000001,47.975,0.9697874933458323 -609,2018-01-22,-106.37500000000001,47.975,0.9697874769612521 -609,2018-01-23,-106.37500000000001,47.975,0.9697874605766721 -609,2018-01-24,-106.37500000000001,47.975,0.9697874441920921 -609,2018-01-25,-106.37500000000001,47.975,0.9697874278075119 -609,2018-01-26,-106.37500000000001,47.975,0.9697874114229319 -609,2018-01-27,-106.37500000000001,47.975,0.9697873950383518 -609,2018-01-28,-106.37500000000001,47.975,0.9697873786537717 -609,2018-01-29,-106.37500000000001,47.975,0.9697873622691917 -609,2018-01-30,-106.37500000000001,47.975,0.9697873458846116 -609,2018-01-31,-106.37500000000001,47.975,0.9697873295000315 -609,2018-02-01,-106.37500000000001,47.975,0.9697873131154514 -609,2018-02-02,-106.37500000000001,47.975,0.9697872980315964 -609,2018-02-03,-106.37500000000001,47.975,0.9697872829477413 -609,2018-02-04,-106.37500000000001,47.975,0.9697872678638862 -609,2018-02-05,-106.37500000000001,47.975,0.9697872527800312 -609,2018-02-06,-106.37500000000001,47.975,0.9697872376961761 -609,2018-02-07,-106.37500000000001,47.975,0.969787222612321 -609,2018-02-08,-106.37500000000001,47.975,0.9697872075284659 -609,2018-02-09,-106.37500000000001,47.975,0.9697871924446109 -609,2018-02-10,-106.37500000000001,47.975,0.9697871773607558 -609,2018-02-11,-106.37500000000001,47.975,0.9697871622769008 -609,2018-02-12,-106.37500000000001,47.975,0.9697871471930457 -609,2018-02-13,-106.37500000000001,47.975,0.9697871321091905 -609,2018-02-14,-106.37500000000001,47.975,0.9697871170253355 -609,2018-02-15,-106.37500000000001,47.975,0.9697871019414804 -609,2018-02-16,-106.37500000000001,47.975,0.9697870868576254 -609,2018-02-17,-106.37500000000001,47.975,0.9697870717737703 -609,2018-02-18,-106.37500000000001,47.975,0.9697870566899153 -609,2018-02-19,-106.37500000000001,47.975,0.9697870416060601 -609,2018-02-20,-106.37500000000001,47.975,0.969787026522205 -609,2018-02-21,-106.37500000000001,47.975,0.96978701143835 -609,2018-02-22,-106.37500000000001,47.975,0.969786996354495 -609,2018-02-23,-106.37500000000001,47.975,0.9697869812706399 -609,2018-02-24,-106.37500000000001,47.975,0.9697869661867848 -609,2018-02-25,-106.37500000000001,47.975,0.9697869511029297 -609,2018-02-26,-106.37500000000001,47.975,0.9697869360190746 -609,2018-02-27,-106.37500000000001,47.975,0.9697869209352196 -609,2018-02-28,-106.37500000000001,47.975,0.9697869058513645 -609,2018-03-01,-106.37500000000001,47.975,0.9697868907675095 -609,2018-03-02,-106.37500000000001,47.975,0.9697868735190026 -609,2018-03-03,-106.37500000000001,47.975,0.9697868562704959 -609,2018-03-04,-106.37500000000001,47.975,0.969786839021989 -609,2018-03-05,-106.37500000000001,47.975,0.9697868217734823 -609,2018-03-06,-106.37500000000001,47.975,0.9697868045249756 -609,2018-03-07,-106.37500000000001,47.975,0.9697867872764687 -609,2018-03-08,-106.37500000000001,47.975,0.969786770027962 -609,2018-03-09,-106.37500000000001,47.975,0.9697867527794551 -609,2018-03-10,-106.37500000000001,47.975,0.9697867355309484 -609,2018-03-11,-106.37500000000001,47.975,0.9697867182824416 -609,2018-03-12,-106.37500000000001,47.975,0.9697867010339348 -609,2018-03-13,-106.37500000000001,47.975,0.969786683785428 -609,2018-03-14,-106.37500000000001,47.975,0.9697866665369212 -609,2018-03-15,-106.37500000000001,47.975,0.9697866492884145 -609,2018-03-16,-106.37500000000001,47.975,0.9697866320399077 -609,2018-03-17,-106.37500000000001,47.975,0.9697866147914009 -609,2018-03-18,-106.37500000000001,47.975,0.9697865975428941 -609,2018-03-19,-106.37500000000001,47.975,0.9697865802943874 -609,2018-03-20,-106.37500000000001,47.975,0.9697865630458805 -609,2018-03-21,-106.37500000000001,47.975,0.9697840656059067 -609,2018-03-22,-106.37500000000001,47.975,0.9697763328484953 -609,2018-03-23,-106.37500000000001,47.975,0.9697653319616238 -609,2018-03-24,-106.37500000000001,47.975,0.9697633433996657 -609,2018-03-25,-106.37500000000001,47.975,0.9697633261511589 -609,2018-03-26,-106.37500000000001,47.975,0.9697633089026522 -609,2018-03-27,-106.37500000000001,47.975,0.9697632916541453 -609,2018-03-28,-106.37500000000001,47.975,0.9697632744056386 -609,2018-03-29,-106.37500000000001,47.975,0.9697632571571317 -609,2018-03-30,-106.37500000000001,47.975,0.969763239908625 -609,2018-03-31,-106.37500000000001,47.975,0.9697632226601182 -609,2018-04-01,-106.37500000000001,47.975,0.9697632054116114 -609,2018-04-02,-106.37500000000001,47.975,0.9697631851236497 -609,2018-04-03,-106.37500000000001,47.975,0.969763164835688 -609,2018-04-04,-106.37500000000001,47.975,0.9697631445477263 -609,2018-04-05,-106.37500000000001,47.975,0.9697631242597645 -609,2018-04-06,-106.37500000000001,47.975,0.9697631039718029 -609,2018-04-07,-106.37500000000001,47.975,0.9697630836838411 -609,2018-04-08,-106.37500000000001,47.975,0.9697630633958795 -609,2018-04-09,-106.37500000000001,47.975,0.9697630431079177 -609,2018-04-10,-106.37500000000001,47.975,0.969763022819956 -609,2018-04-11,-106.37500000000001,47.975,0.9697630025319943 -609,2018-04-12,-106.37500000000001,47.975,0.9697629822440326 -609,2018-04-13,-106.37500000000001,47.975,0.9697629619560708 -609,2018-04-14,-106.37500000000001,47.975,0.9697629416681092 -609,2018-04-15,-106.37500000000001,47.975,0.9697629213801474 -609,2018-04-16,-106.37500000000001,47.975,0.9697629010921858 -609,2018-04-17,-106.37500000000001,47.975,0.969762880804224 -609,2018-04-18,-106.37500000000001,47.975,0.9697628605162623 -609,2018-04-19,-106.37500000000001,47.975,0.9697146805328534 -609,2018-04-20,-106.37500000000001,47.975,0.9695189585189018 -609,2018-04-21,-106.37500000000001,47.975,0.9694300927177428 -609,2018-04-22,-106.37500000000001,47.975,0.9693856916533783 -609,2018-04-23,-106.37500000000001,47.975,0.9693778843696814 -609,2018-04-24,-106.37500000000001,47.975,0.9694057793434101 -609,2018-04-25,-106.37500000000001,47.975,0.9694469887633321 -609,2018-04-26,-106.37500000000001,47.975,0.969470955341674 -609,2018-04-27,-106.37500000000001,47.975,0.9694845413595478 -609,2018-04-28,-106.37500000000001,47.975,0.969527447772868 -609,2018-04-29,-106.37500000000001,47.975,0.9696053232365633 -609,2018-04-30,-106.37500000000001,47.975,0.9696766160580494 -609,2018-05-01,-106.37500000000001,47.975,0.969724678918871 -609,2018-05-02,-106.37500000000001,47.975,0.9697720236251808 -609,2018-05-03,-106.37500000000001,47.975,0.969836485178396 -609,2018-05-04,-106.37500000000001,47.975,0.9699074650156954 -609,2018-05-05,-106.37500000000001,47.975,0.9699775614437715 -609,2018-05-06,-106.37500000000001,47.975,0.97006990007386 -609,2018-05-07,-106.37500000000001,47.975,0.970220397467829 -609,2018-05-08,-106.37500000000001,47.975,0.9704272915598187 -609,2018-05-09,-106.37500000000001,47.975,0.9706588681255419 -609,2018-05-10,-106.37500000000001,47.975,0.97090150985051 -609,2018-05-11,-106.37500000000001,47.975,0.9711906851374686 -609,2018-05-12,-106.37500000000001,47.975,0.9715817286354229 -609,2018-05-13,-106.37500000000001,47.975,0.9720874328381639 -609,2018-05-14,-106.37500000000001,47.975,0.9727602241484896 -609,2018-05-15,-106.37500000000001,47.975,0.9737816043457647 -609,2018-05-16,-106.37500000000001,47.975,0.9753473772733008 -609,2018-05-17,-106.37500000000001,47.975,0.9774401343746372 -609,2018-05-18,-106.37500000000001,47.975,0.9798897839521779 -609,2018-05-19,-106.37500000000001,47.975,0.9822932172215781 -609,2018-05-20,-106.37500000000001,47.975,0.9833497618045168 -609,2018-05-21,-106.37500000000001,47.975,0.9836982078267307 -609,2018-05-22,-106.37500000000001,47.975,0.9837840305518984 -609,2018-05-23,-106.37500000000001,47.975,0.9838337799138774 -609,2018-05-24,-106.37500000000001,47.975,0.983944900829488 -609,2018-05-25,-106.37500000000001,47.975,0.9840906922776503 -609,2018-05-26,-106.37500000000001,47.975,0.9841956463233338 -609,2018-05-27,-106.37500000000001,47.975,0.9842597365452249 -609,2018-05-28,-106.37500000000001,47.975,0.9843555803253937 -609,2018-05-29,-106.37500000000001,47.975,0.9845270939003307 -609,2018-05-30,-106.37500000000001,47.975,0.984750145299376 -609,2018-05-31,-106.37500000000001,47.975,0.9849820000990297 -609,2018-06-01,-106.37500000000001,47.975,0.9851847925947521 -609,2018-06-02,-106.37500000000001,47.975,0.98537633725452 -609,2018-06-03,-106.37500000000001,47.975,0.9854980923009006 -609,2018-06-04,-106.37500000000001,47.975,0.9855405911886197 -609,2018-06-05,-106.37500000000001,47.975,0.9856495695042661 -609,2018-06-06,-106.37500000000001,47.975,0.9858497898857771 -609,2018-06-07,-106.37500000000001,47.975,0.9860217018243297 -609,2018-06-08,-106.37500000000001,47.975,0.9860663814223263 -609,2018-06-09,-106.37500000000001,47.975,0.9860033876407923 -609,2018-06-10,-106.37500000000001,47.975,0.9859000031239316 -609,2018-06-11,-106.37500000000001,47.975,0.9857760523107498 -609,2018-06-12,-106.37500000000001,47.975,0.9856290687950845 -609,2018-06-13,-106.37500000000001,47.975,0.9854508479435682 -609,2018-06-14,-106.37500000000001,47.975,0.9852467455842854 -609,2018-06-15,-106.37500000000001,47.975,0.985032352735622 -609,2018-06-16,-106.37500000000001,47.975,0.9848253929420132 -609,2018-06-17,-106.37500000000001,47.975,0.9846867016625931 -609,2018-06-18,-106.37500000000001,47.975,0.9845878613780243 -609,2018-06-19,-106.37500000000001,47.975,0.9843946469027218 -609,2018-06-20,-106.37500000000001,47.975,0.9841791163700461 -609,2018-06-21,-106.37500000000001,47.975,0.9840187466416258 -609,2018-06-22,-106.37500000000001,47.975,0.9839216306187308 -609,2018-06-23,-106.37500000000001,47.975,0.9839559191712717 -609,2018-06-24,-106.37500000000001,47.975,0.9841865131697488 -609,2018-06-25,-106.37500000000001,47.975,0.9844624334176835 -609,2018-06-26,-106.37500000000001,47.975,0.9846365283036461 -609,2018-06-27,-106.37500000000001,47.975,0.9846683156837295 -609,2018-06-28,-106.37500000000001,47.975,0.9845768129189015 -609,2018-06-29,-106.37500000000001,47.975,0.9844179561595549 -609,2018-06-30,-106.37500000000001,47.975,0.9842881730550761 -609,2018-07-01,-106.37500000000001,47.975,0.9841989542335202 -609,2018-07-02,-106.37500000000001,47.975,0.984041835974844 -609,2018-07-03,-106.37500000000001,47.975,0.9838609057890499 -609,2018-07-04,-106.37500000000001,47.975,0.9837080552937403 -609,2018-07-05,-106.37500000000001,47.975,0.9835644759938482 -609,2018-07-06,-106.37500000000001,47.975,0.9834199145608244 -609,2018-07-07,-106.37500000000001,47.975,0.9832776288376964 -609,2018-07-08,-106.37500000000001,47.975,0.9831487930306848 -609,2018-07-09,-106.37500000000001,47.975,0.9830424932873842 -609,2018-07-10,-106.37500000000001,47.975,0.9829360200416178 -609,2018-07-11,-106.37500000000001,47.975,0.982810736593407 -609,2018-07-12,-106.37500000000001,47.975,0.982679807598582 -609,2018-07-13,-106.37500000000001,47.975,0.9825458871434124 -609,2018-07-14,-106.37500000000001,47.975,0.9824109187897394 -609,2018-07-15,-106.37500000000001,47.975,0.982282262453821 -609,2018-07-16,-106.37500000000001,47.975,0.9821670192505726 -609,2018-07-17,-106.37500000000001,47.975,0.9820676154898688 -609,2018-07-18,-106.37500000000001,47.975,0.9819755334553715 -609,2018-07-19,-106.37500000000001,47.975,0.9818849478944022 -609,2018-07-20,-106.37500000000001,47.975,0.9817993483821849 -609,2018-07-21,-106.37500000000001,47.975,0.9817222082448822 -609,2018-07-22,-106.37500000000001,47.975,0.9816493759592173 -609,2018-07-23,-106.37500000000001,47.975,0.9815848250812872 -609,2018-07-24,-106.37500000000001,47.975,0.9815355388216519 -609,2018-07-25,-106.37500000000001,47.975,0.9815004395313175 -609,2018-07-26,-106.37500000000001,47.975,0.9814619769840279 -609,2018-07-27,-106.37500000000001,47.975,0.9813988940715171 -609,2018-07-28,-106.37500000000001,47.975,0.9813107762588074 -609,2018-07-29,-106.37500000000001,47.975,0.9811899463445436 -609,2018-07-30,-106.37500000000001,47.975,0.9810234200557537 -609,2018-07-31,-106.37500000000001,47.975,0.9808052663894261 -609,2018-08-01,-106.37500000000001,47.975,0.980539141276169 -609,2018-08-02,-106.37500000000001,47.975,0.9802432736811284 -609,2018-08-03,-106.37500000000001,47.975,0.9799485432412522 -609,2018-08-04,-106.37500000000001,47.975,0.9796582733125682 -609,2018-08-05,-106.37500000000001,47.975,0.9793716588182002 -609,2018-08-06,-106.37500000000001,47.975,0.9790883991417685 -609,2018-08-07,-106.37500000000001,47.975,0.9788096155200716 -609,2018-08-08,-106.37500000000001,47.975,0.978538205334747 -609,2018-08-09,-106.37500000000001,47.975,0.9782772126532436 -609,2018-08-10,-106.37500000000001,47.975,0.9780268415310313 -609,2018-08-11,-106.37500000000001,47.975,0.9777837557316491 -609,2018-08-12,-106.37500000000001,47.975,0.9775460197244418 -609,2018-08-13,-106.37500000000001,47.975,0.9773133855020719 -609,2018-08-14,-106.37500000000001,47.975,0.9770841869126267 -609,2018-08-15,-106.37500000000001,47.975,0.9768574848650609 -609,2018-08-16,-106.37500000000001,47.975,0.9766332708352764 -609,2018-08-17,-106.37500000000001,47.975,0.9764119327090416 -609,2018-08-18,-106.37500000000001,47.975,0.9761952939724492 -609,2018-08-19,-106.37500000000001,47.975,0.9759816375830446 -609,2018-08-20,-106.37500000000001,47.975,0.9757673444171486 -609,2018-08-21,-106.37500000000001,47.975,0.9755514299164277 -609,2018-08-22,-106.37500000000001,47.975,0.9753338145220043 -609,2018-08-23,-106.37500000000001,47.975,0.9751162895202631 -609,2018-08-24,-106.37500000000001,47.975,0.9749001538907759 -609,2018-08-25,-106.37500000000001,47.975,0.9746854114522991 -609,2018-08-26,-106.37500000000001,47.975,0.9744712700227149 -609,2018-08-27,-106.37500000000001,47.975,0.9742532978392231 -609,2018-08-28,-106.37500000000001,47.975,0.9740232918123183 -609,2018-08-29,-106.37500000000001,47.975,0.9737756552864454 -609,2018-08-30,-106.37500000000001,47.975,0.9735189271170527 -609,2018-08-31,-106.37500000000001,47.975,0.9732670646543049 -609,2018-09-01,-106.37500000000001,47.975,0.9730262189863973 -609,2018-09-02,-106.37500000000001,47.975,0.9727937633678483 -609,2018-09-03,-106.37500000000001,47.975,0.9725644244376891 -609,2018-09-04,-106.37500000000001,47.975,0.9723350967506221 -609,2018-09-05,-106.37500000000001,47.975,0.9721053857279607 -609,2018-09-06,-106.37500000000001,47.975,0.9718758034024152 -609,2018-09-07,-106.37500000000001,47.975,0.971647896295275 -609,2018-09-08,-106.37500000000001,47.975,0.9714230009225172 -609,2018-09-09,-106.37500000000001,47.975,0.9712009674824676 -609,2018-09-10,-106.37500000000001,47.975,0.9709804248870827 -609,2018-09-11,-106.37500000000001,47.975,0.9707611219318785 -609,2018-09-12,-106.37500000000001,47.975,0.9705438392455147 -609,2018-09-13,-106.37500000000001,47.975,0.9703278876147154 -609,2018-09-14,-106.37500000000001,47.975,0.9701114004757817 -609,2018-09-15,-106.37500000000001,47.975,0.9698937413467745 -609,2018-09-16,-106.37500000000001,47.975,0.9697845372828762 -609,2018-09-17,-106.37500000000001,47.975,0.9697845139578742 -609,2018-09-18,-106.37500000000001,47.975,0.9697844906328723 -609,2018-09-19,-106.37500000000001,47.975,0.9697844673078704 -609,2018-09-20,-106.37500000000001,47.975,0.9697844439828684 -609,2018-09-21,-106.37500000000001,47.975,0.9697844206578665 -609,2018-09-22,-106.37500000000001,47.975,0.9697843973328646 -609,2018-09-23,-106.37500000000001,47.975,0.9697843740078627 -609,2018-09-24,-106.37500000000001,47.975,0.9697843506828607 -609,2018-09-25,-106.37500000000001,47.975,0.9697843273578588 -609,2018-09-26,-106.37500000000001,47.975,0.9697843040328568 -609,2018-09-27,-106.37500000000001,47.975,0.9697842807078548 -609,2018-09-28,-106.37500000000001,47.975,0.9697842573828529 -609,2018-09-29,-106.37500000000001,47.975,0.969784234057851 -609,2018-09-30,-106.37500000000001,47.975,0.969784210732849 -609,2018-10-01,-106.37500000000001,47.975,0.9697841874078471 -609,2018-10-02,-106.37500000000001,47.975,0.9697841671198854 -609,2018-10-03,-106.37500000000001,47.975,0.9697841468319237 -609,2018-10-04,-106.37500000000001,47.975,0.969784126543962 -609,2018-10-05,-106.37500000000001,47.975,0.9697841062560002 -609,2018-10-06,-106.37500000000001,47.975,0.9697840859680386 -609,2018-10-07,-106.37500000000001,47.975,0.9697840656800768 -609,2018-10-08,-106.37500000000001,47.975,0.969784045392115 -609,2018-10-09,-106.37500000000001,47.975,0.9697840251041534 -609,2018-10-10,-106.37500000000001,47.975,0.9697840048161916 -609,2018-10-11,-106.37500000000001,47.975,0.96978398452823 -609,2018-10-12,-106.37500000000001,47.975,0.9697839642402682 -609,2018-10-13,-106.37500000000001,47.975,0.9697839439523065 -609,2018-10-14,-106.37500000000001,47.975,0.9697839236643448 -609,2018-10-15,-106.37500000000001,47.975,0.9697839033763831 -609,2018-10-16,-106.37500000000001,47.975,0.9697838830884213 -609,2018-10-17,-106.37500000000001,47.975,0.9697838628004597 -609,2018-10-18,-106.37500000000001,47.975,0.9697838425124979 -609,2018-10-19,-106.37500000000001,47.975,0.9697838222245362 -609,2018-10-20,-106.37500000000001,47.975,0.9697838019365745 -609,2018-10-21,-106.37500000000001,47.975,0.9697837816486128 -609,2018-10-22,-106.37500000000001,47.975,0.9697837613606511 -609,2018-10-23,-106.37500000000001,47.975,0.9697837410726894 -609,2018-10-24,-106.37500000000001,47.975,0.9697837207847276 -609,2018-10-25,-106.37500000000001,47.975,0.969783700496766 -609,2018-10-26,-106.37500000000001,47.975,0.9697836802088042 -609,2018-10-27,-106.37500000000001,47.975,0.9697836599208425 -609,2018-10-28,-106.37500000000001,47.975,0.9697836396328808 -609,2018-10-29,-106.37500000000001,47.975,0.9697836193449191 -609,2018-10-30,-106.37500000000001,47.975,0.9697835990569574 -609,2018-10-31,-106.37500000000001,47.975,0.9697835787689957 -609,2018-11-01,-106.37500000000001,47.975,0.9697835584810339 -609,2018-11-02,-106.37500000000001,47.975,0.9697835390618318 -609,2018-11-03,-106.37500000000001,47.975,0.9697835196426295 -609,2018-11-04,-106.37500000000001,47.975,0.9697835002234274 -609,2018-11-05,-106.37500000000001,47.975,0.9697834808042253 -609,2018-11-06,-106.37500000000001,47.975,0.969783461385023 -609,2018-11-07,-106.37500000000001,47.975,0.9697834419658209 -609,2018-11-08,-106.37500000000001,47.975,0.9697834225466186 -609,2018-11-09,-106.37500000000001,47.975,0.9697834031274165 -609,2018-11-10,-106.37500000000001,47.975,0.9697833837082144 -609,2018-11-11,-106.37500000000001,47.975,0.9697833642890121 -609,2018-11-12,-106.37500000000001,47.975,0.96978334486981 -609,2018-11-13,-106.37500000000001,47.975,0.9697833254506077 -609,2018-11-14,-106.37500000000001,47.975,0.9697833060314056 -609,2018-11-15,-106.37500000000001,47.975,0.9697832866122034 -609,2018-11-16,-106.37500000000001,47.975,0.9697832671930012 -609,2018-11-17,-106.37500000000001,47.975,0.9697832477737991 -609,2018-11-18,-106.37500000000001,47.975,0.9697832283545968 -609,2018-11-19,-106.37500000000001,47.975,0.9697832089353947 -609,2018-11-20,-106.37500000000001,47.975,0.9697831895161925 -609,2018-11-21,-106.37500000000001,47.975,0.9697831700969903 -609,2018-11-22,-106.37500000000001,47.975,0.9697831506777882 -609,2018-11-23,-106.37500000000001,47.975,0.969783131258586 -609,2018-11-24,-106.37500000000001,47.975,0.9697831118393838 -609,2018-11-25,-106.37500000000001,47.975,0.9697830924201816 -609,2018-11-26,-106.37500000000001,47.975,0.9697830730009794 -609,2018-11-27,-106.37500000000001,47.975,0.9697830535817773 -609,2018-11-28,-106.37500000000001,47.975,0.969783034162575 -609,2018-11-29,-106.37500000000001,47.975,0.9697830147433729 -609,2018-11-30,-106.37500000000001,47.975,0.9697829953241707 -609,2018-12-01,-106.37500000000001,47.975,0.9697829759049685 -609,2018-12-02,-106.37500000000001,47.975,0.9697829586564617 -609,2018-12-03,-106.37500000000001,47.975,0.969782941407955 -609,2018-12-04,-106.37500000000001,47.975,0.9697829241594482 -609,2018-12-05,-106.37500000000001,47.975,0.9697829069109414 -609,2018-12-06,-106.37500000000001,47.975,0.9697828896624346 -609,2018-12-07,-106.37500000000001,47.975,0.9697828724139278 -609,2018-12-08,-106.37500000000001,47.975,0.9697828551654211 -609,2018-12-09,-106.37500000000001,47.975,0.9697828379169142 -609,2018-12-10,-106.37500000000001,47.975,0.9697828206684075 -609,2018-12-11,-106.37500000000001,47.975,0.9697828034199006 -609,2018-12-12,-106.37500000000001,47.975,0.9697827861713939 -609,2018-12-13,-106.37500000000001,47.975,0.9697827689228872 -609,2018-12-14,-106.37500000000001,47.975,0.9697827516743803 -609,2018-12-15,-106.37500000000001,47.975,0.9697827344258736 -609,2018-12-16,-106.37500000000001,47.975,0.9697827171773667 -609,2018-12-17,-106.37500000000001,47.975,0.96978269992886 -609,2018-12-18,-106.37500000000001,47.975,0.9697826826803532 -609,2018-12-19,-106.37500000000001,47.975,0.9697826654318464 -609,2018-12-20,-106.37500000000001,47.975,0.9697826481833396 -609,2018-12-21,-106.37500000000001,47.975,0.9697826309348329 -609,2018-12-22,-106.37500000000001,47.975,0.969782613686326 -609,2018-12-23,-106.37500000000001,47.975,0.9697825964378193 -609,2018-12-24,-106.37500000000001,47.975,0.9697825791893125 -609,2018-12-25,-106.37500000000001,47.975,0.9697825619408057 -609,2018-12-26,-106.37500000000001,47.975,0.969782544692299 -609,2018-12-27,-106.37500000000001,47.975,0.9697825274437921 -609,2018-12-28,-106.37500000000001,47.975,0.9697825101952854 -609,2018-12-29,-106.37500000000001,47.975,0.9697824929467785 -609,2018-12-30,-106.37500000000001,47.975,0.9697824756982718 -609,2018-12-31,-106.37500000000001,47.975,0.969782458449765 -609,2019-01-01,-106.37500000000001,47.975,0.9697824412012582 -609,2019-01-02,-106.37500000000001,47.975,0.9697824239527515 -609,2019-01-03,-106.37500000000001,47.975,0.9697824067042446 -609,2019-01-04,-106.37500000000001,47.975,0.9697823894557379 -609,2019-01-05,-106.37500000000001,47.975,0.9697823722072311 -609,2019-01-06,-106.37500000000001,47.975,0.9697823549587243 -609,2019-01-07,-106.37500000000001,47.975,0.9697823377102175 -609,2019-01-08,-106.37500000000001,47.975,0.9697823204617108 -609,2019-01-09,-106.37500000000001,47.975,0.9697823032132039 -609,2019-01-10,-106.37500000000001,47.975,0.9697822859646972 -609,2019-01-11,-106.37500000000001,47.975,0.9697822687161903 -609,2019-01-12,-106.37500000000001,47.975,0.9697822514676836 -609,2019-01-13,-106.37500000000001,47.975,0.9697822342191769 -609,2019-01-14,-106.37500000000001,47.975,0.96978221697067 -609,2019-01-15,-106.37500000000001,47.975,0.9697821997221633 -609,2019-01-16,-106.37500000000001,47.975,0.9697821824736564 -609,2019-01-17,-106.37500000000001,47.975,0.9697821652251497 -609,2019-01-18,-106.37500000000001,47.975,0.9697821479766429 -609,2019-01-19,-106.37500000000001,47.975,0.9697821307281361 -609,2019-01-20,-106.37500000000001,47.975,0.9697821134796293 -609,2019-01-21,-106.37500000000001,47.975,0.9697820962311225 -609,2019-01-22,-106.37500000000001,47.975,0.9697820789826158 -609,2019-01-23,-106.37500000000001,47.975,0.969782061734109 -609,2019-01-24,-106.37500000000001,47.975,0.9697820444856022 -609,2019-01-25,-106.37500000000001,47.975,0.9697820272370954 -609,2019-01-26,-106.37500000000001,47.975,0.9697820099885887 -609,2019-01-27,-106.37500000000001,47.975,0.9697819927400818 -609,2019-01-28,-106.37500000000001,47.975,0.9697819754915751 -609,2019-01-29,-106.37500000000001,47.975,0.9697819582430682 -609,2019-01-30,-106.37500000000001,47.975,0.9697819409945615 -609,2019-01-31,-106.37500000000001,47.975,0.9697819237460547 -609,2019-02-01,-106.37500000000001,47.975,0.9697819064975479 -609,2019-02-02,-106.37500000000001,47.975,0.9697818922816495 -609,2019-02-03,-106.37500000000001,47.975,0.9697818780657511 -609,2019-02-04,-106.37500000000001,47.975,0.9697818638498527 -609,2019-02-05,-106.37500000000001,47.975,0.9697818496339542 -609,2019-02-06,-106.37500000000001,47.975,0.9697818354180557 -609,2019-02-07,-106.37500000000001,47.975,0.9697818212021573 -609,2019-02-08,-106.37500000000001,47.975,0.9697818069862589 -609,2019-02-09,-106.37500000000001,47.975,0.9697817927703605 -609,2019-02-10,-106.37500000000001,47.975,0.969781778554462 -609,2019-02-11,-106.37500000000001,47.975,0.9697817643385636 -609,2019-02-12,-106.37500000000001,47.975,0.9697817501226652 -609,2019-02-13,-106.37500000000001,47.975,0.9697817359067668 -609,2019-02-14,-106.37500000000001,47.975,0.9697817216908683 -609,2019-02-15,-106.37500000000001,47.975,0.9697817074749698 -609,2019-02-16,-106.37500000000001,47.975,0.9697816932590715 -609,2019-02-17,-106.37500000000001,47.975,0.969781679043173 -609,2019-02-18,-106.37500000000001,47.975,0.9697816648272746 -609,2019-02-19,-106.37500000000001,47.975,0.9697816506113761 -609,2019-02-20,-106.37500000000001,47.975,0.9697816363954778 -609,2019-02-21,-106.37500000000001,47.975,0.9697816221795793 -609,2019-02-22,-106.37500000000001,47.975,0.9697816079636808 -609,2019-02-23,-106.37500000000001,47.975,0.9697815937477824 -609,2019-02-24,-106.37500000000001,47.975,0.969781579531884 -609,2019-02-25,-106.37500000000001,47.975,0.9697815653159856 -609,2019-02-26,-106.37500000000001,47.975,0.9697815511000871 -609,2019-02-27,-106.37500000000001,47.975,0.9697815368841887 -609,2019-02-28,-106.37500000000001,47.975,0.9697815226682902 -609,2019-03-01,-106.37500000000001,47.975,0.9697815084523919 -609,2019-03-02,-106.37500000000001,47.975,0.9697814920678117 -609,2019-03-03,-106.37500000000001,47.975,0.9697814756832317 -609,2019-03-04,-106.37500000000001,47.975,0.9697814592986517 -609,2019-03-05,-106.37500000000001,47.975,0.9697814429140715 -609,2019-03-06,-106.37500000000001,47.975,0.9697814265294915 -609,2019-03-07,-106.37500000000001,47.975,0.9697814101449114 -609,2019-03-08,-106.37500000000001,47.975,0.9697813937603313 -609,2019-03-09,-106.37500000000001,47.975,0.9697813773757513 -609,2019-03-10,-106.37500000000001,47.975,0.9697813609911712 -609,2019-03-11,-106.37500000000001,47.975,0.9697813446065912 -609,2019-03-12,-106.37500000000001,47.975,0.969781328222011 -609,2019-03-13,-106.37500000000001,47.975,0.969781311837431 -609,2019-03-14,-106.37500000000001,47.975,0.969781295452851 -609,2019-03-15,-106.37500000000001,47.975,0.9697812790682708 -609,2019-03-16,-106.37500000000001,47.975,0.9697812626836908 -609,2019-03-17,-106.37500000000001,47.975,0.9697812462991107 -609,2019-03-18,-106.37500000000001,47.975,0.9697812299145306 -609,2019-03-19,-106.37500000000001,47.975,0.9697812135299506 -609,2019-03-20,-106.37500000000001,47.975,0.9697811971453705 -609,2019-03-21,-106.37500000000001,47.975,0.9697811807607905 -609,2019-03-22,-106.37500000000001,47.975,0.9697811643762103 -609,2019-03-23,-106.37500000000001,47.975,0.9697811479916303 -609,2019-03-24,-106.37500000000001,47.975,0.9697811316070503 -609,2019-03-25,-106.37500000000001,47.975,0.9697811152224701 -609,2019-03-26,-106.37500000000001,47.975,0.9697810988378901 -609,2019-03-27,-106.37500000000001,47.975,0.96978108245331 -609,2019-03-28,-106.37500000000001,47.975,0.9697810660687299 -609,2019-03-29,-106.37500000000001,47.975,0.9697810496841499 -609,2019-03-30,-106.37500000000001,47.975,0.9697810332995698 -609,2019-03-31,-106.37500000000001,47.975,0.9697810169149897 -609,2019-04-01,-106.37500000000001,47.975,0.9697810005304096 -609,2019-04-02,-106.37500000000001,47.975,0.9697809789421249 -609,2019-04-03,-106.37500000000001,47.975,0.9697809573538402 -609,2019-04-04,-106.37500000000001,47.975,0.9697809357655554 -609,2019-04-05,-106.37500000000001,47.975,0.9697809141772706 -609,2019-04-06,-106.37500000000001,47.975,0.9697808925889858 -609,2019-04-07,-106.37500000000001,47.975,0.9697808710007011 -609,2019-04-08,-106.37500000000001,47.975,0.9697808494124163 -609,2019-04-09,-106.37500000000001,47.975,0.9697808278241316 -609,2019-04-10,-106.37500000000001,47.975,0.9697808062358467 -609,2019-04-11,-106.37500000000001,47.975,0.969780784647562 -609,2019-04-12,-106.37500000000001,47.975,0.9697807630592773 -609,2019-04-13,-106.37500000000001,47.975,0.9697807414709925 -609,2019-04-14,-106.37500000000001,47.975,0.9697807198827078 -609,2019-04-15,-106.37500000000001,47.975,0.9697806982944229 -609,2019-04-16,-106.37500000000001,47.975,0.9696605287293735 -609,2019-04-17,-106.37500000000001,47.975,0.9696000568812517 -609,2019-04-18,-106.37500000000001,47.975,0.9696628213721658 -609,2019-04-19,-106.37500000000001,47.975,0.9697343944466393 -609,2019-04-20,-106.37500000000001,47.975,0.96976378559525 -609,2019-04-21,-106.37500000000001,47.975,0.969755503399711 -609,2019-04-22,-106.37500000000001,47.975,0.9697432865289032 -609,2019-04-23,-106.37500000000001,47.975,0.9697493873415165 -609,2019-04-24,-106.37500000000001,47.975,0.9697892343206224 -609,2019-04-25,-106.37500000000001,47.975,0.9698657599894803 -609,2019-04-26,-106.37500000000001,47.975,0.9700002666287882 -609,2019-04-27,-106.37500000000001,47.975,0.9702401519575357 -609,2019-04-28,-106.37500000000001,47.975,0.97061496026871 -609,2019-04-29,-106.37500000000001,47.975,0.9711566836894701 -609,2019-04-30,-106.37500000000001,47.975,0.9719106208216302 -609,2019-05-01,-106.37500000000001,47.975,0.9728398748564671 -609,2019-05-02,-106.37500000000001,47.975,0.9738612636811106 -609,2019-05-03,-106.37500000000001,47.975,0.9749095327680396 -609,2019-05-04,-106.37500000000001,47.975,0.9759440593014409 -609,2019-05-05,-106.37500000000001,47.975,0.9769426193614382 -609,2019-05-06,-106.37500000000001,47.975,0.977877253381993 -609,2019-05-07,-106.37500000000001,47.975,0.9787198615859152 -609,2019-05-08,-106.37500000000001,47.975,0.9794573381432757 -609,2019-05-09,-106.37500000000001,47.975,0.9800777076520375 -609,2019-05-10,-106.37500000000001,47.975,0.9805780482881243 -609,2019-05-11,-106.37500000000001,47.975,0.9809723205733237 -609,2019-05-12,-106.37500000000001,47.975,0.9812739121893708 -609,2019-05-13,-106.37500000000001,47.975,0.9814873766344165 -609,2019-05-14,-106.37500000000001,47.975,0.9815629408410229 -609,2019-05-15,-106.37500000000001,47.975,0.9815609869287178 -609,2019-05-16,-106.37500000000001,47.975,0.981543832822896 -609,2019-05-17,-106.37500000000001,47.975,0.9815306651774693 -609,2019-05-18,-106.37500000000001,47.975,0.9815514670544687 -609,2019-05-19,-106.37500000000001,47.975,0.9816342010791935 -609,2019-05-20,-106.37500000000001,47.975,0.9817249651996359 -609,2019-05-21,-106.37500000000001,47.975,0.981744881988747 -609,2019-05-22,-106.37500000000001,47.975,0.9817419390783445 -609,2019-05-23,-106.37500000000001,47.975,0.9818109052234731 -609,2019-05-24,-106.37500000000001,47.975,0.9819578975209682 -609,2019-05-25,-106.37500000000001,47.975,0.9821069072277865 -609,2019-05-26,-106.37500000000001,47.975,0.9822136271584899 -609,2019-05-27,-106.37500000000001,47.975,0.9822759198304551 -609,2019-05-28,-106.37500000000001,47.975,0.9823024830153461 -609,2019-05-29,-106.37500000000001,47.975,0.9822953013607986 -609,2019-05-30,-106.37500000000001,47.975,0.98227303377444 -609,2019-05-31,-106.37500000000001,47.975,0.9823039985350762 -609,2019-06-01,-106.37500000000001,47.975,0.9823812627471654 -609,2019-06-02,-106.37500000000001,47.975,0.9824401497474834 -609,2019-06-03,-106.37500000000001,47.975,0.9824482005601028 -609,2019-06-04,-106.37500000000001,47.975,0.9824203770942268 -609,2019-06-05,-106.37500000000001,47.975,0.9823913587303271 -609,2019-06-06,-106.37500000000001,47.975,0.9823816559003029 -609,2019-06-07,-106.37500000000001,47.975,0.9823812099605044 -609,2019-06-08,-106.37500000000001,47.975,0.982371335398819 -609,2019-06-09,-106.37500000000001,47.975,0.9823651004308179 -609,2019-06-10,-106.37500000000001,47.975,0.9823689159866554 -609,2019-06-11,-106.37500000000001,47.975,0.9823791469297315 -609,2019-06-12,-106.37500000000001,47.975,0.9824064794353736 -609,2019-06-13,-106.37500000000001,47.975,0.9824549210360422 -609,2019-06-14,-106.37500000000001,47.975,0.9825095448683697 -609,2019-06-15,-106.37500000000001,47.975,0.9825413123394937 -609,2019-06-16,-106.37500000000001,47.975,0.9825383728091931 -609,2019-06-17,-106.37500000000001,47.975,0.9825081355252216 -609,2019-06-18,-106.37500000000001,47.975,0.9824531696836031 -609,2019-06-19,-106.37500000000001,47.975,0.9823860855457068 -609,2019-06-20,-106.37500000000001,47.975,0.9823337349479491 -609,2019-06-21,-106.37500000000001,47.975,0.982289139787095 -609,2019-06-22,-106.37500000000001,47.975,0.9823492894285636 -609,2019-06-23,-106.37500000000001,47.975,0.9825293820690919 -609,2019-06-24,-106.37500000000001,47.975,0.982566220252092 -609,2019-06-25,-106.37500000000001,47.975,0.982440552198605 -609,2019-06-26,-106.37500000000001,47.975,0.9822889995378529 -609,2019-06-27,-106.37500000000001,47.975,0.9821739276001574 -609,2019-06-28,-106.37500000000001,47.975,0.9820904973232718 -609,2019-06-29,-106.37500000000001,47.975,0.9820594764496307 -609,2019-06-30,-106.37500000000001,47.975,0.9820601655963679 -609,2019-07-01,-106.37500000000001,47.975,0.9820303436874631 -609,2019-07-02,-106.37500000000001,47.975,0.9819671177092391 -609,2019-07-03,-106.37500000000001,47.975,0.9818969259835226 -609,2019-07-04,-106.37500000000001,47.975,0.9818443311309066 -609,2019-07-05,-106.37500000000001,47.975,0.9818041829249158 -609,2019-07-06,-106.37500000000001,47.975,0.9817602786804165 -609,2019-07-07,-106.37500000000001,47.975,0.9817117262282427 -609,2019-07-08,-106.37500000000001,47.975,0.9816609826356332 -609,2019-07-09,-106.37500000000001,47.975,0.9816162138108139 -609,2019-07-10,-106.37500000000001,47.975,0.9816230856484696 -609,2019-07-11,-106.37500000000001,47.975,0.9816610206494044 -609,2019-07-12,-106.37500000000001,47.975,0.9816531660387329 -609,2019-07-13,-106.37500000000001,47.975,0.9816116360071555 -609,2019-07-14,-106.37500000000001,47.975,0.9815736453061127 -609,2019-07-15,-106.37500000000001,47.975,0.9815506843659116 -609,2019-07-16,-106.37500000000001,47.975,0.9815373967059539 -609,2019-07-17,-106.37500000000001,47.975,0.9815274992497882 -609,2019-07-18,-106.37500000000001,47.975,0.9815176121487841 -609,2019-07-19,-106.37500000000001,47.975,0.9815052967082188 -609,2019-07-20,-106.37500000000001,47.975,0.981495036758444 -609,2019-07-21,-106.37500000000001,47.975,0.9814855767014393 -609,2019-07-22,-106.37500000000001,47.975,0.9814727755118858 -609,2019-07-23,-106.37500000000001,47.975,0.9814470796415493 -609,2019-07-24,-106.37500000000001,47.975,0.9813909473065275 -609,2019-07-25,-106.37500000000001,47.975,0.9813029418134024 -609,2019-07-26,-106.37500000000001,47.975,0.9811851498126073 -609,2019-07-27,-106.37500000000001,47.975,0.9810293886600346 -609,2019-07-28,-106.37500000000001,47.975,0.9808376469694982 -609,2019-07-29,-106.37500000000001,47.975,0.9806038698464196 -609,2019-07-30,-106.37500000000001,47.975,0.9803181163569695 -609,2019-07-31,-106.37500000000001,47.975,0.9800315251331108 -609,2019-08-01,-106.37500000000001,47.975,0.9797601251524461 -609,2019-08-02,-106.37500000000001,47.975,0.9795023562207041 -609,2019-08-03,-106.37500000000001,47.975,0.9792564225222439 -609,2019-08-04,-106.37500000000001,47.975,0.9790195424409605 -609,2019-08-05,-106.37500000000001,47.975,0.9787879839666384 -609,2019-08-06,-106.37500000000001,47.975,0.9785592123913425 -609,2019-08-07,-106.37500000000001,47.975,0.9783328315069056 -609,2019-08-08,-106.37500000000001,47.975,0.9781088420704851 -609,2019-08-09,-106.37500000000001,47.975,0.9778864307736491 -609,2019-08-10,-106.37500000000001,47.975,0.9776651445194185 -609,2019-08-11,-106.37500000000001,47.975,0.9774449709035112 -609,2019-08-12,-106.37500000000001,47.975,0.9772242916395123 -609,2019-08-13,-106.37500000000001,47.975,0.9769971716051651 -609,2019-08-14,-106.37500000000001,47.975,0.9767633377241848 -609,2019-08-15,-106.37500000000001,47.975,0.9765304521143807 -609,2019-08-16,-106.37500000000001,47.975,0.9763014761609667 -609,2019-08-17,-106.37500000000001,47.975,0.9760759788931166 -609,2019-08-18,-106.37500000000001,47.975,0.9758494697821487 -609,2019-08-19,-106.37500000000001,47.975,0.9756174622817771 -609,2019-08-20,-106.37500000000001,47.975,0.9753814999545611 -609,2019-08-21,-106.37500000000001,47.975,0.9751452917854324 -609,2019-08-22,-106.37500000000001,47.975,0.9749114148258373 -609,2019-08-23,-106.37500000000001,47.975,0.9746810545991735 -609,2019-08-24,-106.37500000000001,47.975,0.9744515443793504 -609,2019-08-25,-106.37500000000001,47.975,0.9742186021837834 -609,2019-08-26,-106.37500000000001,47.975,0.9739844354083198 -609,2019-08-27,-106.37500000000001,47.975,0.9737538186440011 -609,2019-08-28,-106.37500000000001,47.975,0.9735278167126284 -609,2019-08-29,-106.37500000000001,47.975,0.9733060296772539 -609,2019-08-30,-106.37500000000001,47.975,0.9730884060580485 -609,2019-08-31,-106.37500000000001,47.975,0.9728719772094567 -609,2019-09-01,-106.37500000000001,47.975,0.9726537497174352 -609,2019-09-02,-106.37500000000001,47.975,0.9724339268921781 -609,2019-09-03,-106.37500000000001,47.975,0.9722138769095942 -609,2019-09-04,-106.37500000000001,47.975,0.9719956488932385 -609,2019-09-05,-106.37500000000001,47.975,0.9717802444515332 -609,2019-09-06,-106.37500000000001,47.975,0.9715675020898028 -609,2019-09-07,-106.37500000000001,47.975,0.9713559250864743 -609,2019-09-08,-106.37500000000001,47.975,0.971126320520215 -609,2019-09-09,-106.37500000000001,47.975,0.9708617430710924 -609,2019-09-10,-106.37500000000001,47.975,0.9705824397603822 -609,2019-09-11,-106.37500000000001,47.975,0.9703034967046854 -609,2019-09-12,-106.37500000000001,47.975,0.9700277815930644 -609,2019-09-13,-106.37500000000001,47.975,0.9697513627674894 -609,2019-09-14,-106.37500000000001,47.975,0.9695267934802613 -609,2019-09-15,-106.37500000000001,47.975,0.9694350993261437 -609,2019-09-16,-106.37500000000001,47.975,0.9694350328482516 -609,2019-09-17,-106.37500000000001,47.975,0.9694349529969939 -609,2019-09-18,-106.37500000000001,47.975,0.9694349283777316 -609,2019-09-19,-106.37500000000001,47.975,0.9694349037584694 -609,2019-09-20,-106.37500000000001,47.975,0.9694348791392071 -609,2019-09-21,-106.37500000000001,47.975,0.9694348545199449 -609,2019-09-22,-106.37500000000001,47.975,0.9694348299006826 -609,2019-09-23,-106.37500000000001,47.975,0.9694348052814205 -609,2019-09-24,-106.37500000000001,47.975,0.9694347806621583 -609,2019-09-25,-106.37500000000001,47.975,0.9694347486600805 -609,2019-09-26,-106.37500000000001,47.975,0.9694347240408182 -609,2019-09-27,-106.37500000000001,47.975,0.969434699421556 -609,2019-09-28,-106.37500000000001,47.975,0.9694346748022937 -609,2019-09-29,-106.37500000000001,47.975,0.9694346501830315 -609,2019-09-30,-106.37500000000001,47.975,0.9694346255637694 -609,2019-10-01,-106.37500000000001,47.975,0.9691960947281518 -609,2019-10-02,-106.37500000000001,47.975,0.968994650348649 -609,2019-10-03,-106.37500000000001,47.975,0.9688185377326642 -609,2019-10-04,-106.37500000000001,47.975,0.968818518313462 -609,2019-10-05,-106.37500000000001,47.975,0.9688184988942599 -609,2019-10-06,-106.37500000000001,47.975,0.9688184794750577 -609,2019-10-07,-106.37500000000001,47.975,0.9688184600558555 -609,2019-10-08,-106.37500000000001,47.975,0.9688184406366533 -609,2019-10-09,-106.37500000000001,47.975,0.9688184212174511 -609,2019-10-10,-106.37500000000001,47.975,0.968818401798249 -609,2019-10-11,-106.37500000000001,47.975,0.9688183823790467 -609,2019-10-12,-106.37500000000001,47.975,0.9688183629598446 -609,2019-10-13,-106.37500000000001,47.975,0.9688183435406424 -609,2019-10-14,-106.37500000000001,47.975,0.9688183241214402 -609,2019-10-15,-106.37500000000001,47.975,0.9688183047022381 -609,2019-10-16,-106.37500000000001,47.975,0.9688182852830358 -609,2019-10-17,-106.37500000000001,47.975,0.9688182658638337 -609,2019-10-18,-106.37500000000001,47.975,0.9688182464446315 -609,2019-10-19,-106.37500000000001,47.975,0.9688182270254293 -609,2019-10-20,-106.37500000000001,47.975,0.9688182076062272 -609,2019-10-21,-106.37500000000001,47.975,0.9688181881870249 -609,2019-10-22,-106.37500000000001,47.975,0.9688181687678228 -609,2019-10-23,-106.37500000000001,47.975,0.9688181493486206 -609,2019-10-24,-106.37500000000001,47.975,0.9688181299294184 -609,2019-10-25,-106.37500000000001,47.975,0.9688181105102163 -609,2019-10-26,-106.37500000000001,47.975,0.968818091091014 -609,2019-10-27,-106.37500000000001,47.975,0.9688180716718119 -609,2019-10-28,-106.37500000000001,47.975,0.9688180522526096 -609,2019-10-29,-106.37500000000001,47.975,0.9688180328334075 -609,2019-10-30,-106.37500000000001,47.975,0.9688180134142054 -609,2019-10-31,-106.37500000000001,47.975,0.9688179939950031 -609,2019-11-01,-106.37500000000001,47.975,0.968817974575801 -609,2019-11-02,-106.37500000000001,47.975,0.9688179551565987 -609,2019-11-03,-106.37500000000001,47.975,0.9688179357373966 -609,2019-11-04,-106.37500000000001,47.975,0.9688179163181945 -609,2019-11-05,-106.37500000000001,47.975,0.9688178968989922 -609,2019-11-06,-106.37500000000001,47.975,0.9688178774797901 -609,2019-11-07,-106.37500000000001,47.975,0.9688178580605878 -609,2019-11-08,-106.37500000000001,47.975,0.9688178386413857 -609,2019-11-09,-106.37500000000001,47.975,0.9688178192221836 -609,2019-11-10,-106.37500000000001,47.975,0.9688177998029813 -609,2019-11-11,-106.37500000000001,47.975,0.9688177803837792 -609,2019-11-12,-106.37500000000001,47.975,0.968817760964577 -609,2019-11-13,-106.37500000000001,47.975,0.9688177415453748 -609,2019-11-14,-106.37500000000001,47.975,0.9688177221261726 -609,2019-11-15,-106.37500000000001,47.975,0.9688177027069704 -609,2019-11-16,-106.37500000000001,47.975,0.9688176832877683 -609,2019-11-17,-106.37500000000001,47.975,0.968817663868566 -609,2019-11-18,-106.37500000000001,47.975,0.9688176444493639 -609,2019-11-19,-106.37500000000001,47.975,0.9688176250301617 -609,2019-11-20,-106.37500000000001,47.975,0.9688176056109595 -609,2019-11-21,-106.37500000000001,47.975,0.9688175861917574 -609,2019-11-22,-106.37500000000001,47.975,0.9688175667725551 -609,2019-11-23,-106.37500000000001,47.975,0.968817547353353 -609,2019-11-24,-106.37500000000001,47.975,0.9688175279341508 -609,2019-11-25,-106.37500000000001,47.975,0.9688175085149486 -609,2019-11-26,-106.37500000000001,47.975,0.9688174890957465 -609,2019-11-27,-106.37500000000001,47.975,0.9688174696765443 -609,2019-11-28,-106.37500000000001,47.975,0.9688174502573421 -609,2019-11-29,-106.37500000000001,47.975,0.9688174308381399 -609,2019-11-30,-106.37500000000001,47.975,0.9688174114189377 -609,2019-12-01,-106.37500000000001,47.975,0.9688173919997355 -609,2019-12-02,-106.37500000000001,47.975,0.9688173743172499 -609,2019-12-03,-106.37500000000001,47.975,0.9688173566347643 -609,2019-12-04,-106.37500000000001,47.975,0.9688173389522787 -609,2019-12-05,-106.37500000000001,47.975,0.9688173212697931 -609,2019-12-06,-106.37500000000001,47.975,0.9688173035873076 -609,2019-12-07,-106.37500000000001,47.975,0.9688172859048219 -609,2019-12-08,-106.37500000000001,47.975,0.9688172682223363 -609,2019-12-09,-106.37500000000001,47.975,0.9688172505398507 -609,2019-12-10,-106.37500000000001,47.975,0.9688172328573651 -609,2019-12-11,-106.37500000000001,47.975,0.9688172151748795 -609,2019-12-12,-106.37500000000001,47.975,0.9688171974923939 -609,2019-12-13,-106.37500000000001,47.975,0.9688171798099082 -609,2019-12-14,-106.37500000000001,47.975,0.9688171621274226 -609,2019-12-15,-106.37500000000001,47.975,0.968817144444937 -609,2019-12-16,-106.37500000000001,47.975,0.9688171267624515 -609,2019-12-17,-106.37500000000001,47.975,0.9688171090799659 -609,2019-12-18,-106.37500000000001,47.975,0.9688170913974803 -609,2019-12-19,-106.37500000000001,47.975,0.9688170737149946 -609,2019-12-20,-106.37500000000001,47.975,0.968817056032509 -609,2019-12-21,-106.37500000000001,47.975,0.9688170383500234 -609,2019-12-22,-106.37500000000001,47.975,0.9688170206675378 -609,2019-12-23,-106.37500000000001,47.975,0.9688170029850522 -609,2019-12-24,-106.37500000000001,47.975,0.9688169853025667 -609,2019-12-25,-106.37500000000001,47.975,0.968816967620081 -609,2019-12-26,-106.37500000000001,47.975,0.9688169499375954 -609,2019-12-27,-106.37500000000001,47.975,0.9688169322551098 -609,2019-12-28,-106.37500000000001,47.975,0.9688169145726242 -609,2019-12-29,-106.37500000000001,47.975,0.9688168968901386 -609,2019-12-30,-106.37500000000001,47.975,0.968816879207653 -609,2019-12-31,-106.37500000000001,47.975,0.9688168615251673 -609,2020-01-01,-106.37500000000001,47.975,0.9688168438426817 diff --git a/tests/data/ncextract/expected.nc b/tests/data/ncextract/expected.nc new file mode 100644 index 0000000..3d86019 Binary files /dev/null and b/tests/data/ncextract/expected.nc differ diff --git a/tests/data/ncextract/ldd.nc b/tests/data/ncextract/ldd.nc new file mode 100644 index 0000000..8dc1a39 Binary files /dev/null and b/tests/data/ncextract/ldd.nc differ diff --git a/tests/data/ncextract/reservoirs.csv b/tests/data/ncextract/reservoirs.csv new file mode 100644 index 0000000..a2a3595 --- /dev/null +++ b/tests/data/ncextract/reservoirs.csv @@ -0,0 +1,9 @@ +ResID,lat,lon +14,44.475,-109.225 +31,48.625,-109.975 +48,44.825,-111.325 +146,43.425,-108.175 +169,48.325,-111.125 +227,45.325,-107.975 +364,46.625,-111.675 +609,47.975,-106.375 diff --git a/tests/data/ncextract/stations.csv b/tests/data/ncextract/stations.csv deleted file mode 100644 index 7d2b6b4..0000000 --- a/tests/data/ncextract/stations.csv +++ /dev/null @@ -1,9 +0,0 @@ -id,lat,lon -14,44.475000000000001,-109.22499999999999 -31,48.625,-109.97499999999999 -48,44.825000000000003,-111.325 -146,43.424999999999997,-108.175 -169,48.325000000000003,-111.125 -227,45.325000000000003,-107.97499999999999 -364,46.625,-111.675 -609,47.975000000000001,-106.375 diff --git a/tests/test_ncextract.py b/tests/test_ncextract.py index 465adbe..2d4882b 100644 --- a/tests/test_ncextract.py +++ b/tests/test_ncextract.py @@ -1,43 +1,77 @@ import unittest # from lisfloodutilities.compare.nc import NetCDFComparator -from lisfloodutilities.ncextract import read_points, read_inputmaps, extract_timeseries -import csv +from lisfloodutilities.ncextract import read_points, read_inputmaps, read_ldd, extract_timeseries, rename_geographic_coords +import numpy as np +import xarray as xr +from datetime import datetime + + class TestExtract(unittest.TestCase): - def compare_csv_files(self, file1, file2): + + def compare_datasets( + self, + dataset1: xr.Dataset, + dataset2: xr.Dataset + ) -> bool: """ - Compare the content of two CSV files and return True if they are identical, False otherwise. + Compare the content of two xarray.Datasets and return True if they are identical, False otherwise. """ - with open(file1, 'r') as f1, open(file2, 'r') as f2: - reader1 = csv.reader(f1) - reader2 = csv.reader(f2) + # Check if both datasets have the same dimensions + if set(dataset1.dims) != set(dataset2.dims): + return False - for row1, row2 in zip(reader1, reader2): - if row1 != row2: - return False + # Check if both datasets have the same coordinates + if not all((dataset1.coords[dim] == dataset2.coords[dim]).all() for dim in dataset1.coords): + return False - # Check if both files have the same number of rows - if len(list(reader1)) != len(list(reader2)): + # Check if both datasets have the same variables + if set(dataset1.data_vars) != set(dataset2.data_vars): + return False + + # Check if the variables' values are the same + for var in dataset1.data_vars: + if not np.allclose(dataset1[var].values, dataset2[var].values): return False + + # all tests passed + return True + + def test_ncextract(self): - return True + # config + inputcsv = 'tests/data/ncextract/reservoirs.csv' + data_dir = 'tests/data/ncextract/datasets' + ldd_file = 'tests/data/ncextract/ldd.nc' + expected_file = 'tests/data/ncextract/expected.nc' + start = datetime(2018, 10, 2) + end = datetime(2019, 10, 1) - def test_extract_csv(self): - inputcsv = 'tests/data/ncextract/stations.csv' - datasets = 'tests/data/ncextract/datasets' - outputfile = 'tests/data/output.csv' - expected = 'tests/data/ncextract/expected.csv' + # read expected results + expected = xr.open_dataset(expected_file) + + # read maps + maps = read_inputmaps(data_dir, start=start, end=end)['dis24'] + + # read points of interest poi = read_points(inputcsv) - maps = read_inputmaps(datasets) - extract_timeseries(maps, poi, outputfile) - assert self.compare_csv_files(outputfile, expected) - - # def test_extract_nc(self): - # inputcsv = 'tests/data/ncextract/stations.csv' - # datasets = 'tests/data/ncextract/datasets' - # outputfile = 'tests/data/output.nc' - # expected = 'tests/data/ncextract/expected.nc' - # extract(inputcsv, datasets, outputfile, nc=True) - # comp = NetCDFComparator(None, for_testing=True) - # comp.compare_files(outputfile, expected) - # assert comp.errors == None + poi = rename_geographic_coords(poi, maps) + + # read LDD + ldd = read_ldd(ldd_file) + ldd = rename_geographic_coords(ldd, maps) + + # extract outflow timeseries + print('Extracting reservoir outflow...') + outflow = extract_timeseries(maps, poi, inflow=False) + outflow.name = 'outflow' + + # extract inflow timeseries + print('Extracting reservoir inflow...') + inflow = extract_timeseries(maps, poi, inflow=True, ldd=ldd) + inflow.name = 'inflow' + + # merge both extractions + output = xr.merge((outflow, inflow)) + + self.assertTrue(self.compare_datasets(output, expected)) \ No newline at end of file